Cubic lattice reorganisation in SPH#

The cubic lattice is not stable in SPH, this test is a way to explore that.

 9 import os
10 import random
11
12 import matplotlib
13 import matplotlib.pyplot as plt
14 import numpy as np
15 from mpl_toolkits.mplot3d import Axes3D
16
17 import shamrock
18
19 # If we use the shamrock executable to run this script instead of the python interpreter,
20 # we should not initialize the system as the shamrock executable needs to handle specific MPI logic
21 if not shamrock.sys.is_initialized():
22     shamrock.change_loglevel(1)
23     shamrock.sys.init("0:0")

Setup parameters

29 gamma = 5.0 / 3.0
30 rho_g = 1
31 P_0 = 1.0
32 u_0 = P_0 / ((gamma - 1.0) * rho_g)
33 perturb = 3e-3
34
35 bmin = (-0.6, -0.6, -0.6)
36 bmax = (0.6, 0.6, 0.6)
37
38 dump_folder = "_to_trash"
39 sim_name = "cubic_reorganisation"
40
41 N_side = 8
42 scheduler_split_val = int(2e7)
43 scheduler_merge_val = int(1)
44
45 os.makedirs(dump_folder, exist_ok=True)

Deduced quantities

50 xm, ym, zm = bmin
51 xM, yM, zM = bmax
52 vol_b = (xM - xm) * (yM - ym) * (zM - zm)
53
54 dr = (bmax[0] - bmin[0]) / N_side
55
56 pmass = -1

Setup

 61 ctx = shamrock.Context()
 62 ctx.pdata_layout_new()
 63
 64 model = shamrock.get_Model_SPH(context=ctx, vector_type="f64_3", sph_kernel="M6")
 65
 66 cfg = model.gen_default_config()
 67 cfg.set_artif_viscosity_VaryingCD10(
 68     alpha_min=0.0, alpha_max=1, sigma_decay=0.1, alpha_u=1, beta_AV=2
 69 )
 70 cfg.set_boundary_periodic()
 71 cfg.set_eos_adiabatic(gamma)
 72 cfg.print_status()
 73 model.set_solver_config(cfg)
 74 model.init_scheduler(scheduler_split_val, scheduler_merge_val)
 75
 76
 77 model.resize_simulation_box(bmin, bmax)
 78
 79 setup = model.get_setup()
 80 gen = setup.make_generator_lattice_cubic(dr, bmin, bmax)
 81 setup.apply_setup(gen, insert_step=scheduler_split_val)
 82
 83
 84 xc, yc, zc = model.get_closest_part_to((0, 0, 0))
 85
 86 if shamrock.sys.world_rank() == 0:
 87     print("closest part to (0,0,0) is in :", xc, yc, zc)
 88
 89
 90 vol_b = (xM - xm) * (yM - ym) * (zM - zm)
 91
 92 totmass = rho_g * vol_b
 93
 94 pmass = model.total_mass_to_part_mass(totmass)
 95
 96 model.set_value_in_a_box("uint", "f64", u_0, bmin, bmax)
 97
 98 tot_u = pmass * model.get_sum("uint", "f64")
 99 if shamrock.sys.world_rank() == 0:
100     print("total u :", tot_u)
101
102 model.set_particle_mass(pmass)
103
104 model.set_cfl_cour(0.1)
105 model.set_cfl_force(0.1)
106
107
108 def periodic_modulo(x, xmin, xmax):
109     tmp = x - xmin
110     tmp = tmp % (xmax - xmin)
111     tmp += xmin
112     return tmp
113
114
115 random.seed(111)
116
117
118 def perturb_func(r):
119     x, y, z = r
120     x += perturb * (random.random() - 0.5) * 2
121     y += perturb * (random.random() - 0.5) * 2
122     z += perturb * (random.random() - 0.5) * 2
123
124     x = periodic_modulo(x, xm, xM)
125     y = periodic_modulo(y, ym, yM)
126     z = periodic_modulo(z, zm, zM)
127
128     return (x, y, z)
129
130
131 model.remap_positions(perturb_func)
----- SPH Solver configuration -----
[
    {
        "artif_viscosity": {
            "alpha_max": 1.0,
            "alpha_min": 0.0,
            "alpha_u": 1.0,
            "av_type": "varying_cd10",
            "beta_AV": 2.0,
            "sigma_decay": 0.1
        },
        "boundary_config": {
            "bc_type": "periodic"
        },
        "cfl_config": {
            "cfl_cour": 0.0,
            "cfl_force": 0.0,
            "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",
            "eos_type": "adiabatic",
            "gamma": 1.6666666666666667
        },
        "epsilon_h": 1e-06,
        "ext_force_config": {
            "force_list": []
        },
        "gpart_mass": 0.0,
        "h_iter_per_subcycles": 50,
        "h_max_subcycles_count": 100,
        "htol_up_coarse_cycle": 1.1,
        "htol_up_fine_cycle": 1.1,
        "kernel_id": "M6<f64>",
        "mhd_config": {
            "mhd_type": "none"
        },
        "particle_killing": [],
        "particle_reordering_step_freq": 1000,
        "self_grav_config": {
            "softening_length": 1e-09,
            "softening_mode": "plummer",
            "type": "none"
        },
        "show_neigh_stats": false,
        "smoothing_length_config": {
            "type": "density_based"
        },
        "time_state": {
            "cfl_multiplier": 0.01,
            "dt_sph": 0.0,
            "time": 0.0
        },
        "tree_reduction_level": 3,
        "type_id": "sycl::vec<f64,3>",
        "unit_sys": null,
        "use_two_stage_search": true
    }
]
------------------------------------
SPH setup: generating particles ...
SPH setup: Nstep = 512 ( 5.1e+02 ) Ntotal = 512 ( 5.1e+02 ) rate = 2.996723e+05 N.s^-1
SPH setup: the generation step took : 0.00284919 s
SPH setup: final particle count = 512 begining injection ...
Info: ---------------------------------------------                   [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     : 12.23 us   (74.6%)
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1411.00 ns (0.3%)
   patch tree reduce : 988.00 ns  (0.2%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1358.00 ns (0.3%)
   LB compute        : 434.64 us  (96.0%)
   LB move op cnt    : 0
   LB apply          : 9.88 us    (2.2%)
Info: Compute load ...                                                [DataInserterUtility][rank=0]
Info: run scheduler step ...                                          [DataInserterUtility][rank=0]
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.81 us    (66.6%)
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1282.00 ns (0.3%)
   patch tree reduce : 883.00 ns  (0.2%)
   gen split merge   : 425.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 274.00 ns  (0.1%)
   LB compute        : 403.43 us  (98.0%)
   LB move op cnt    : 0
   LB apply          : 2.05 us    (0.5%)
Info: Compute load ...                                                [DataInserterUtility][rank=0]
Info: run scheduler step ...                                          [DataInserterUtility][rank=0]
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.78 us    (71.0%)
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1211.00 ns (0.3%)
   patch tree reduce : 580.00 ns  (0.2%)
   gen split merge   : 418.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 270.00 ns  (0.1%)
   LB compute        : 363.45 us  (98.1%)
   LB move op cnt    : 0
   LB apply          : 1889.00 ns (0.5%)
Info: ---------------------------------------------                   [DataInserterUtility][rank=0]
SPH setup: injected          512 / 512 => 100.0% | ranks with patchs = 1 / 1  <- global loop ->
SPH setup: the injection step took : 0.00834705 s
Info: injection perf report:                                                    [SPH setup][rank=0]
+======+====================+=======+=============+=============+=============+
| rank | rank get (sum/max) |  MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+====================+=======+=============+=============+=============+
| 0    |      0.00s / 0.00s | 0.00s |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+--------------------+-------+-------------+-------------+-------------+
SPH setup: the setup took : 0.012554662000000001 s
closest part to (0,0,0) is in : 0.0 0.0 0.0
total u : 2.5919999999999996
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 31.95 us   (55.9%)
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.91 us    (0.3%)
   patch tree reduce : 7.17 us    (0.8%)
   gen split merge   : 803.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 784.00 ns  (0.1%)
   LB compute        : 847.13 us  (97.0%)
   LB move op cnt    : 0
   LB apply          : 9.60 us    (1.1%)

Single timestep to iterate the smoothing length

135 model.timestep()
136
137 hmean = None
138 scatter_range = None
139
140
141 def make_plot(model, iplot):
142     # %%
143     # Recover data
144     dat = ctx.collect_data()
145
146     min_hpart = np.min(dat["hpart"])
147     max_hpart = np.max(dat["hpart"])
148     mean_hpart = np.mean(dat["hpart"])
149
150     global hmean
151     if hmean is None:
152         hmean = mean_hpart
153
154     global scatter_range
155     if scatter_range is None:
156         scatter_range = (min_hpart, max_hpart)
157
158     print(f"hpart min={min_hpart} max={max_hpart} delta={max_hpart - min_hpart}")
159
160     # Compute all pairwise distances
161     from scipy.spatial.distance import pdist
162
163     pairwise_distances = pdist(dat["xyz"])  # Returns condensed distance matrix
164     print(f"Number of particle pairs: {len(pairwise_distances)}")
165     print(
166         f"Distance min={np.min(pairwise_distances):.6f} max={np.max(pairwise_distances):.6f} mean={np.mean(pairwise_distances):.6f}"
167     )
168
169     # %%
170     # Plot particle distrib
171
172     fig = plt.figure(dpi=120, figsize=(10, 5))
173     ax = fig.add_subplot(121, projection="3d")
174     ax.set_xlim3d(bmin[0], bmax[0])
175     ax.set_ylim3d(bmin[1], bmax[1])
176     ax.set_zlim3d(bmin[2], bmax[2])
177     ax.set_aspect("equal")
178
179     cm = matplotlib.colormaps["viridis"]
180     sc = ax.scatter(
181         dat["xyz"][:, 0],
182         dat["xyz"][:, 1],
183         dat["xyz"][:, 2],
184         s=5,
185         vmin=scatter_range[0],
186         vmax=scatter_range[1],
187         c=dat["hpart"],
188         cmap=cm,
189         edgecolors="black",
190         linewidths=0.5,
191     )
192     cbar = plt.colorbar(sc, ax=ax, orientation="horizontal", pad=0.1, aspect=30)
193     cbar.set_label("hpart")
194     ax.set_title(f"t = {model.get_time():0.3f}")
195
196     ax = fig.add_subplot(122)
197
198     # Filter distances to the display range
199     max_dist = hmean * 3
200     filtered_distances = pairwise_distances[pairwise_distances <= max_dist] / hmean
201
202     # Create histogram and normalize by distance^2
203     bins = 500
204     counts, bin_edges = np.histogram(filtered_distances, bins=bins)
205     bin_centers = (bin_edges[:-1] + bin_edges[1:]) / 2
206
207     # Avoid division by zero for the first bin
208     normalized_counts = np.where(bin_centers > 0, counts / (bin_centers**2), 0)
209
210     normalized_counts = normalized_counts / len(dat["xyz"])
211
212     ax.bar(bin_centers, normalized_counts, width=bin_edges[1] - bin_edges[0], align="center")
213     ax.set_xlabel("distances / hmean")
214     ax.set_ylabel("counts / (r^2 * number of particles)")
215     ax.set_xlim(0, 3)
216     ax.set_ylim(0, 1.5)
217
218     plt.tight_layout()
219     plt.savefig(os.path.join(dump_folder, f"{sim_name}_{iplot:04}.png"))
220     plt.close(fig)
221
222
223 tcur = 0
224 for iplot in range(50):
225     model.evolve_until(tcur)
226     make_plot(model, iplot)
227     tcur += 0.5
---------------- t = 0, dt = 0 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 21.60 us   (2.0%)
   patch tree reduce : 3.38 us    (0.3%)
   gen split merge   : 497.00 ns  (0.0%)
   split / merge op  : 0/0
   apply split merge : 888.00 ns  (0.1%)
   LB compute        : 992.99 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 11.47 us   (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (75.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (0,0,0)
    sum a = (-1.9395422767853887e-16,8.805456364058272e-18,3.0824951965935377e-17)
    sum e = 2.5919999999999996
    sum de = 0
Info: CFL hydro = 0.00011562606709629723 sink sink = inf                              [SPH][rank=0]
Info: cfl dt = 0.00011562606709629723 cfl multiplier : 0.01                    [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.2133e+04 |  512 |      1 | 4.220e-02 | 0.1% |   4.3% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 0 (tsim/hr)                                             [sph::Model][rank=0]
Info: iteration since start : 1                                                       [SPH][rank=0]
Info: time since start : 1729.008048154 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14927261075047352 max=0.1507237498505323 delta=0.0014511391000587848
Number of particle pairs: 130816
Distance min=0.144259 max=1.991431 mean=0.805668
---------------- t = 0, dt = 0.00011562606709629723 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.33 us    (1.4%)
   patch tree reduce : 1346.00 ns (0.2%)
   gen split merge   : 472.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.1%)
   LB compute        : 655.85 us  (96.3%)
   LB move op cnt    : 0
   LB apply          : 5.71 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.22 us    (79.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.201226871677113e-20,1.2235390923088368e-21,3.6891990622069016e-21)
    sum a = (-1.8669440993157593e-16,-7.025630077706068e-18,1.168889204178347e-16)
    sum e = 2.592000000336766
    sum de = -2.6469779601696886e-22
Info: CFL hydro = 0.003931011225662891 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.003931011225662891 cfl multiplier : 0.34                      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6212e+04 |  512 |      1 | 3.158e-02 | 0.1% |   3.3% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 13.18019481135017 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.00011562606709629723, dt = 0.003931011225662891 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.4%)
   patch tree reduce : 1362.00 ns (0.4%)
   gen split merge   : 702.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1142.00 ns (0.4%)
   LB compute        : 294.42 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.53 us    (70.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.693430853321359e-19,-3.585998685495806e-20,4.755564838405599e-19)
    sum a = (-1.7606228974731407e-16,6.55725473919233e-17,-1.0149693585592701e-16)
    sum e = 2.592000389227657
    sum de = -9.317362419797304e-21
Info: CFL hydro = 0.006456413066119474 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006456413066119474 cfl multiplier : 0.56                      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9322e+04 |  512 |      1 | 2.650e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 534.0561494149256 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.004046637292759188, dt = 0.006456413066119474 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.4%)
   patch tree reduce : 1177.00 ns (0.4%)
   gen split merge   : 752.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 883.00 ns  (0.3%)
   LB compute        : 308.88 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.83727544896678e-18,6.227928329299859e-19,-5.677221388313003e-19)
    sum a = (5.3394788590566124e-17,-1.7985612998927537e-17,6.092977684890588e-17)
    sum e = 2.5920010449742854
    sum de = 1.4230153513872246e-19
Info: CFL hydro = 0.008104921983139432 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008104921983139432 cfl multiplier : 0.7066666666666667        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9368e+04 |  512 |      1 | 2.644e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 879.2542190097093 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.010503050358878663, dt = 0.008104921983139432 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.76 us    (1.2%)
   patch tree reduce : 1160.00 ns (0.4%)
   gen split merge   : 796.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 840.00 ns  (0.3%)
   LB compute        : 293.68 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.530597239541193e-19,1.2441219929271163e-19,3.898858774893654e-19)
    sum a = (-1.424329404420277e-16,7.681355551625302e-18,5.62167500051114e-17)
    sum e = 2.5920016138383
    sum de = -1.0164395367051604e-20
Info: CFL hydro = 0.009161944496805225 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009161944496805225 cfl multiplier : 0.8044444444444444        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9602e+04 |  512 |      1 | 2.612e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1117.0674503175067 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.018607972342018095, dt = 0.009161944496805225 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.2%)
   patch tree reduce : 1334.00 ns (0.4%)
   gen split merge   : 655.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1195.00 ns (0.4%)
   LB compute        : 317.74 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.38 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (70.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.8058610122838612e-18,3.0444397003392963e-19,8.588100933529241e-19)
    sum a = (4.065497938299245e-17,1.16157083951407e-16,7.663206007257895e-17)
    sum e = 2.5920019680314845
    sum de = 2.439454888092385e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010812606393466031
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.0945159669161218e-18,7.230544288305829e-19,9.790142329636764e-19)
    sum a = (-2.0936377631564083e-17,-5.573666528313482e-17,1.3670705192869726e-16)
    sum e = 2.5919999796558146
    sum de = -9.215718466126788e-19
Info: CFL hydro = 0.004913276103582039 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004913276103582039 cfl multiplier : 0.4348148148148148        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4708e+04 |  512 |      1 | 3.481e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 947.5076836084132 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.027769916838823322, dt = 0.004913276103582039 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.6%)
   patch tree reduce : 1385.00 ns (0.5%)
   gen split merge   : 721.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 985.00 ns  (0.3%)
   LB compute        : 284.60 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.4062783016143284e-18,-3.512815038853034e-19,1.9219855199557878e-18)
    sum a = (-5.901529265273098e-18,-2.03368571982665e-16,3.1978326237025454e-17)
    sum e = 2.592000550454897
    sum de = 7.047314121155779e-19
Info: CFL hydro = 0.0070128662127198725 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070128662127198725 cfl multiplier : 0.6232098765432098       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8691e+04 |  512 |      1 | 2.739e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 645.7011156396466 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.03268319294240536, dt = 0.0070128662127198725 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.4%)
   patch tree reduce : 2.16 us    (0.7%)
   gen split merge   : 780.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 309.36 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.42 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.962785402959133e-18,-2.0227959932062056e-18,1.9283890890370302e-18)
    sum a = (-5.526828994462107e-17,-5.714179129867603e-18,-1.2990975482851662e-16)
    sum e = 2.592001050573768
    sum de = -1.700842158086635e-18
Info: CFL hydro = 0.00837818618411533 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00837818618411533 cfl multiplier : 0.7488065843621398         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9133e+04 |  512 |      1 | 2.676e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 943.447961193467 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 0.03969605915512524, dt = 0.00837818618411533 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.3%)
   patch tree reduce : 2.28 us    (0.7%)
   gen split merge   : 789.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1093.00 ns (0.3%)
   LB compute        : 320.86 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.2493539109390567e-18,-1.3114509478384662e-18,3.42133548054957e-19)
    sum a = (3.067858467264983e-17,5.938999292354196e-17,-1.3121535108462368e-16)
    sum e = 2.5920013595975115
    sum de = -2.7647155398380363e-18
Info: CFL hydro = 0.009255153106258405 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009255153106258405 cfl multiplier : 0.8325377229080931        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9753e+04 |  512 |      1 | 2.592e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1163.6296524375707 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.04807424533924057, dt = 0.009255153106258405 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.5%)
   patch tree reduce : 1385.00 ns (0.5%)
   gen split merge   : 988.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 935.00 ns  (0.3%)
   LB compute        : 282.65 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1873.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.3828595346886414e-18,-4.625206467823162e-19,-9.38946186426759e-19)
    sum a = (9.873352135869595e-17,-9.601694439531628e-17,-2.0362617841884757e-17)
    sum e = 2.592001437583204
    sum de = -4.445228907190568e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011629793646146903
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.973031113489121e-18,-1.1299555041643928e-18,-4.566659550508944e-19)
    sum a = (-1.9240858906144353e-16,-1.0426035035315805e-16,4.906231670931405e-18)
    sum e = 2.5919999437361767
    sum de = -2.3852447794681098e-18
Info: CFL hydro = 0.004906626412711239 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004906626412711239 cfl multiplier : 0.4441792409693644        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4371e+04 |  512 |      1 | 3.563e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 935.2187507087145 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.057329398445498975, dt = 0.004906626412711239 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.56 us    (1.5%)
   patch tree reduce : 1619.00 ns (0.5%)
   gen split merge   : 650.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 287.02 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.86 us    (1.3%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1912.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.0748654450695194e-18,-1.6861512186494565e-18,-3.845800631077645e-19)
    sum a = (-9.852275245636477e-17,3.4566099982313855e-17,6.633365731700813e-17)
    sum e = 2.5920003660559083
    sum de = -2.236166980751353e-18
Info: CFL hydro = 0.006930349649104312 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006930349649104312 cfl multiplier : 0.6294528273129095        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9222e+04 |  512 |      1 | 2.664e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 663.1576197417027 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.06223602485821021, dt = 0.006930349649104312 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.3%)
   patch tree reduce : 1374.00 ns (0.4%)
   gen split merge   : 676.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 998.00 ns  (0.3%)
   LB compute        : 291.07 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.481766520403329e-18,-1.2821774891813576e-18,4.1678086763058397e-19)
    sum a = (7.086518871712855e-17,6.0888794006785925e-18,-7.817184399794286e-17)
    sum e = 2.592000648414031
    sum de = 8.131516293641283e-20
Info: CFL hydro = 0.008254406012291101 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008254406012291101 cfl multiplier : 0.7529685515419396        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9137e+04 |  512 |      1 | 2.675e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 932.5408582499714 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.06916637450731453, dt = 0.008254406012291101 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.4%)
   patch tree reduce : 1487.00 ns (0.5%)
   gen split merge   : 674.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 284.76 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1988.00 ns (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.7235839411842166e-18,-1.1826477297471882e-18,-8.628351939182765e-19)
    sum a = (7.88275694718621e-17,-2.393397979805201e-17,-4.929650437857091e-18)
    sum e = 2.5920007591539242
    sum de = -8.131516293641283e-20
Info: CFL hydro = 0.009114493431217757 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009114493431217757 cfl multiplier : 0.8353123676946265        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9247e+04 |  512 |      1 | 2.660e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1117.0825575914434 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.07742078051960563, dt = 0.009114493431217757 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1707.00 ns (0.6%)
   gen split merge   : 808.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 911.00 ns  (0.3%)
   LB compute        : 288.60 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.46 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.9771107454279466e-18,-1.375852556884105e-18,-5.957148836721604e-19)
    sum a = (1.2365108936762681e-17,1.0112223558511601e-16,-1.8465697720904118e-17)
    sum e = 2.5920007020264886
    sum de = 2.0328790734103208e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011320175979560353
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.2493539109390567e-18,-6.557254739192331e-19,-6.747532220463536e-19)
    sum a = (6.814861175374887e-18,1.9671764217576992e-17,1.3899038170395172e-17)
    sum e = 2.5919999241452607
    sum de = -3.469446951953614e-18
Info: CFL hydro = 0.004835316275440013 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004835316275440013 cfl multiplier : 0.44510412256487547       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4353e+04 |  512 |      1 | 3.567e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 919.8149321778594 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.08653527395082339, dt = 0.004835316275440013 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.5%)
   patch tree reduce : 1422.00 ns (0.5%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 272.37 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (63.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.4630501591359496e-18,-9.016225266389456e-19,-5.1960389116367795e-19)
    sum a = (-1.5149600324226854e-16,-5.784435430644663e-17,4.1205320405746095e-17)
    sum e = 2.592000145444104
    sum de = 2.1819568721270777e-18
Info: CFL hydro = 0.006828156494012182 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006828156494012182 cfl multiplier : 0.6300694150432503        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9693e+04 |  512 |      1 | 2.600e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 669.5333993457435 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.0913705902262634, dt = 0.006828156494012182 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.02 us    (1.3%)
   patch tree reduce : 1514.00 ns (0.5%)
   gen split merge   : 684.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 906.00 ns  (0.3%)
   LB compute        : 287.86 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1941.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.34710861058063e-18,-1.756407519426517e-18,8.782037597132586e-21)
    sum a = (-6.145084441300241e-17,-1.2824116768506144e-16,-1.8451060991575564e-17)
    sum e = 2.5920002501167625
    sum de = -2.846030702774449e-19
Info: CFL hydro = 0.008139658820736412 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008139658820736412 cfl multiplier : 0.7533796100288335        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9592e+04 |  512 |      1 | 2.613e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 940.6097713160793 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.09819874672027558, dt = 0.008139658820736412 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1210.00 ns (0.4%)
   gen split merge   : 648.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 992.00 ns  (0.3%)
   LB compute        : 276.91 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.324842129728058e-18,-2.8043973393510057e-18,-3.732365978781349e-20)
    sum a = (-1.969518298450268e-17,1.1381520725883831e-17,-1.119402422318505e-16)
    sum e = 2.5920002518172214
    sum de = 5.773376568485311e-18
Info: CFL hydro = 0.009000017457213903 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009000017457213903 cfl multiplier : 0.835586406685889         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0100e+04 |  512 |      1 | 2.547e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1150.3445114776673 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.106338405541012, dt = 0.009000017457213903 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.6%)
   patch tree reduce : 1413.00 ns (0.5%)
   gen split merge   : 1100.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 278.75 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1833.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.859394137080031e-18,-2.20721878274599e-18,-1.6671234705223359e-18)
    sum a = (-1.1742169736539408e-16,-4.8219241099989315e-17,2.3235807809079967e-17)
    sum e = 2.592000179259087
    sum de = -5.014435047745458e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010879604306784238
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.929650437857091e-18,-2.6873035047225714e-18,-1.008470650737392e-18)
    sum a = (-1.6571119476616047e-16,-1.669055518793705e-16,-5.51607099840562e-17)
    sum e = 2.5919999271624183
    sum de = 5.312590645178972e-18
Info: CFL hydro = 0.004783835794912726 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004783835794912726 cfl multiplier : 0.4451954688952964        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4132e+04 |  512 |      1 | 3.623e-02 | 0.1% |   2.3% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 894.318648814391 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 0.1153384229982259, dt = 0.004783835794912726 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.5%)
   patch tree reduce : 1370.00 ns (0.5%)
   gen split merge   : 724.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 909.00 ns  (0.3%)
   LB compute        : 279.65 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1964.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.106443475872858e-18,-3.823113700618386e-18,-1.7264022243029808e-18)
    sum a = (-3.786814611883571e-17,1.164263997710524e-16,-5.631627976454557e-17)
    sum e = 2.5919999984594844
    sum de = 2.9680034471790684e-18
Info: CFL hydro = 0.006762805825947055 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006762805825947055 cfl multiplier : 0.6301303125968643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9826e+04 |  512 |      1 | 2.583e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 666.8637436379503 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.12012225879313862, dt = 0.006762805825947055 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.89 us    (1.6%)
   patch tree reduce : 1174.00 ns (0.4%)
   gen split merge   : 724.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 839.00 ns  (0.3%)
   LB compute        : 295.57 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.44 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.1386442803956775e-18,-2.587773745288402e-18,-1.913752359708476e-18)
    sum a = (-1.0842889086593032e-17,-8.502183332370627e-17,9.115425699413732e-17)
    sum e = 2.5920000213141625
    sum de = -1.3417001884508117e-18
Info: CFL hydro = 0.0080752144438109 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0080752144438109 cfl multiplier : 0.7534202083979095          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9903e+04 |  512 |      1 | 2.573e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 946.3915298507388 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.12688506461908566, dt = 0.0080752144438109 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.80 us    (1.6%)
   patch tree reduce : 1611.00 ns (0.5%)
   gen split merge   : 740.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 896.00 ns  (0.3%)
   LB compute        : 288.15 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.755161971987555e-18,-3.805549625424121e-18,-8.38684590526162e-19)
    sum a = (-7.599389867385397e-17,1.7466887311523572e-16,2.1483791308452015e-17)
    sum e = 2.5920000227197377
    sum de = 2.981555974335137e-19
Info: CFL hydro = 0.008946965862260308 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008946965862260308 cfl multiplier : 0.8356134722652729        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9564e+04 |  512 |      1 | 2.617e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1110.8059712209636 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.13496027906289657, dt = 0.008946965862260308 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 1424.00 ns (0.5%)
   gen split merge   : 679.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 800.00 ns  (0.3%)
   LB compute        : 285.84 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1917.00 ns (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.428451521101053e-18,-1.3524337899584183e-18,-8.269752070633185e-19)
    sum a = (1.95663797664114e-17,1.030308650895595e-16,-2.3465604459538268e-17)
    sum e = 2.592000035666445
    sum de = -6.911788849595091e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010351711705034653
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.750459566329248e-18,-1.5280745419010699e-18,-9.477282240238915e-19)
    sum a = (3.7317805096082065e-17,-1.4554763644314406e-17,-1.2799087961354316e-16)
    sum e = 2.5919999502335602
    sum de = -3.6591823321385775e-18
Info: CFL hydro = 0.004766452145536542 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004766452145536542 cfl multiplier : 0.445204490755091         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5022e+04 |  512 |      1 | 3.408e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 945.02127940644 (tsim/hr)                               [sph::Model][rank=0]
---------------- t = 0.14390724492515689, dt = 0.004766452145536542 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 2.14 us    (0.7%)
   gen split merge   : 783.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 915.00 ns  (0.3%)
   LB compute        : 269.17 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1897.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.948366799124471e-18,-2.1311077902375074e-18,-1.9152160326413316e-18)
    sum a = (-1.5807667674838656e-17,1.0411983775160394e-16,6.065460633752906e-18)
    sum e = 2.5919999715606323
    sum de = -8.944667923005412e-19
Info: CFL hydro = 0.006746300047022442 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006746300047022442 cfl multiplier : 0.6301363271700606        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0251e+04 |  512 |      1 | 2.528e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 678.6971704384 (tsim/hr)                                [sph::Model][rank=0]
---------------- t = 0.14867369707069342, dt = 0.006746300047022442 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 1197.00 ns (0.4%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 818.00 ns  (0.3%)
   LB compute        : 287.73 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.293793611278353e-18,-1.2411946470614055e-18,-1.7864128145500534e-18)
    sum a = (-1.0813615627935924e-16,-5.351188242519456e-17,2.1978512759757153e-17)
    sum e = 2.592000023173982
    sum de = 3.279711571768651e-18
Info: CFL hydro = 0.008069190673341617 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008069190673341617 cfl multiplier : 0.7534242181133738        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0103e+04 |  512 |      1 | 2.547e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 953.5629935762839 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.15541999711771587, dt = 0.008069190673341617 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.5%)
   patch tree reduce : 1442.00 ns (0.5%)
   gen split merge   : 722.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 284.43 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.412039731979903e-18,-2.4940986775856545e-18,-1.7176201867058483e-18)
    sum a = (4.02919884956443e-17,1.5824060811686635e-16,-2.6589082498251758e-17)
    sum e = 2.592000116955499
    sum de = 4.0793106739767104e-18
Info: CFL hydro = 0.008958301542154611 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008958301542154611 cfl multiplier : 0.8356161454089159        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0046e+04 |  512 |      1 | 2.554e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1137.3522907418303 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.16348918779105748, dt = 0.008958301542154611 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.81 us    (1.5%)
   patch tree reduce : 1042.00 ns (0.3%)
   gen split merge   : 752.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 905.00 ns  (0.3%)
   LB compute        : 301.38 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.63 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.65 us    (73.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.75631425806067e-18,2.458970527197124e-19,-1.7889742421825503e-18)
    sum a = (-7.224689596574407e-17,1.3536047283047026e-17,-4.2329421218179066e-18)
    sum e = 2.592000272359789
    sum de = 1.3552527156068805e-20
Info: CFL hydro = 0.009562592762024334 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009562592762024334 cfl multiplier : 0.890410763605944         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0298e+04 |  512 |      1 | 2.522e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1278.5008302259678 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.17244748933321208, dt = 0.009562592762024334 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.4%)
   patch tree reduce : 1266.00 ns (0.4%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 969.00 ns  (0.3%)
   LB compute        : 275.44 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1659.00 ns (63.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.763321235865206e-18,-5.093581806336899e-19,-1.6499253135612845e-18)
    sum a = (8.289658022520019e-17,-3.433191231305699e-17,1.0895581312175828e-16)
    sum e = 2.592000496985449
    sum de = -1.5449880957918438e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010904736053589686
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.136869220603081e-18,-6.440160904563896e-19,-9.038180360382286e-19)
    sum a = (-2.2768896143499084e-17,-2.4402355136565743e-16,7.059001820575172e-17)
    sum e = 2.5920000244573527
    sum de = -5.041540102057596e-18
Info: CFL hydro = 0.004992298476275283 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004992298476275283 cfl multiplier : 0.46347025453531465       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5060e+04 |  512 |      1 | 3.400e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1012.6132871131481 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.18201008209523642, dt = 0.004992298476275283 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.4%)
   patch tree reduce : 1230.00 ns (0.4%)
   gen split merge   : 969.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 910.00 ns  (0.3%)
   LB compute        : 282.11 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.57 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.511569491414071e-18,-2.5526455948998717e-18,-7.530597239541193e-19)
    sum a = (-6.81017742198975e-17,-1.5006745845980162e-16,-1.619407732911249e-17)
    sum e = 2.5920001435174718
    sum de = -5.597193715456417e-18
Info: CFL hydro = 0.006929601870494426 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006929601870494426 cfl multiplier : 0.6423135030235431        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0096e+04 |  512 |      1 | 2.548e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 705.4172016485841 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.1870023805715117, dt = 0.006929601870494426 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.5%)
   patch tree reduce : 1291.00 ns (0.5%)
   gen split merge   : 727.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 911.00 ns  (0.3%)
   LB compute        : 269.96 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.231696574378943e-18,-3.817259008886964e-18,-1.265711168686734e-18)
    sum a = (-6.52080928316423e-17,-6.369904603786835e-17,-6.422596829369631e-18)
    sum e = 2.59200036594552
    sum de = 1.4907779871675686e-19
Info: CFL hydro = 0.008236792561514722 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008236792561514722 cfl multiplier : 0.7615423353490286        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0326e+04 |  512 |      1 | 2.519e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 990.3657196969776 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.19393198244200613, dt = 0.008236792561514722 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.13 us    (1.8%)
   patch tree reduce : 1335.00 ns (0.5%)
   gen split merge   : 888.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 917.00 ns  (0.3%)
   LB compute        : 267.43 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.62 us    (71.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.55955931133856e-18,-4.051446678143833e-18,-1.1080004101715613e-18)
    sum a = (8.16531900687395e-17,-5.957734305894746e-17,-1.0670175680516092e-16)
    sum e = 2.5920006557265305
    sum de = 6.776263578034403e-20
Info: CFL hydro = 0.009128379194648666 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009128379194648666 cfl multiplier : 0.841028223566019         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9691e+04 |  512 |      1 | 2.600e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1140.4135278642086 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.20216877500352085, dt = 0.009128379194648666 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.6%)
   patch tree reduce : 1731.00 ns (0.6%)
   gen split merge   : 662.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 906.00 ns  (0.3%)
   LB compute        : 267.74 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1941.00 ns (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.365202198128529e-18,-4.560804858777523e-18,-2.7206020639450324e-18)
    sum a = (-1.4610675950349483e-16,3.934352843515398e-18,-7.341783431202841e-18)
    sum e = 2.592000997818788
    sum de = 2.019326546254252e-18
Info: CFL hydro = 0.00974666412172616 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00974666412172616 cfl multiplier : 0.8940188157106794         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8304e+04 |  512 |      1 | 2.797e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1174.8541959618208 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.21129715419816952, dt = 0.00974666412172616 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.59 us    (1.5%)
   patch tree reduce : 1872.00 ns (0.6%)
   gen split merge   : 771.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 999.00 ns  (0.3%)
   LB compute        : 293.89 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.03 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.74806173281717e-18,-4.420292257223401e-18,-2.0392623137008293e-18)
    sum a = (6.914976403982198e-17,-9.086481567166515e-18,1.1635028877854393e-16)
    sum e = 2.592001367684139
    sum de = -7.792703114739563e-19
Info: CFL hydro = 0.010185875168572094 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010185875168572094 cfl multiplier : 0.9293458771404529        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9223e+04 |  512 |      1 | 2.664e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1317.3497324626053 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.2210438183198957, dt = 0.010185875168572094 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.71 us    (1.5%)
   patch tree reduce : 1207.00 ns (0.4%)
   gen split merge   : 729.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 292.25 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.249260649573209e-18,-4.48469386626904e-18,-4.079988300334514e-19)
    sum a = (-1.5167164399421118e-16,-3.362934930528638e-17,3.674404530640274e-17)
    sum e = 2.592001736704449
    sum de = 3.6676526616111205e-19
Info: CFL hydro = 0.010479782685932025 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010479782685932025 cfl multiplier : 0.9528972514269686        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9492e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1395.9920208036767 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.23122969348846778, dt = 0.010479782685932025 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.4%)
   patch tree reduce : 1240.00 ns (0.4%)
   gen split merge   : 688.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 971.00 ns  (0.3%)
   LB compute        : 280.06 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1899.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0819470319667346e-17,-4.947214513051357e-18,-2.3546838307311748e-19)
    sum a = (-1.0430718788700943e-16,5.751649156948701e-17,1.7066426397094325e-17)
    sum e = 2.5920020666568417
    sum de = -1.438261944437802e-18
Info: CFL hydro = 0.010672601681151946 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010672601681151946 cfl multiplier : 0.9685981676179791        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9488e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1436.0034272258274 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.2417094761743998, dt = 0.010672601681151946 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.56 us    (1.6%)
   patch tree reduce : 1230.00 ns (0.4%)
   gen split merge   : 1052.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 940.00 ns  (0.3%)
   LB compute        : 276.68 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1621563086872122e-17,-3.643081929877168e-18,-1.3280544876705449e-19)
    sum a = (-8.931917705456982e-17,-1.817296313433303e-17,7.799034855426878e-17)
    sum e = 2.5920023299859305
    sum de = -1.8295911660692887e-19
Info: CFL hydro = 0.010793422382330758 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010793422382330758 cfl multiplier : 0.9790654450786528        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9717e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1479.5792418849678 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.2523820778555518, dt = 0.010793422382330758 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.49 us    (1.4%)
   patch tree reduce : 1156.00 ns (0.4%)
   gen split merge   : 667.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 925.00 ns  (0.3%)
   LB compute        : 296.75 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.249391215485396e-17,-4.57763709750536e-18,9.620447748983837e-19)
    sum a = (7.695406811780713e-17,8.412021079706732e-17,-3.023362810106178e-17)
    sum e = 2.592002508361038
    sum de = 1.4501204056993622e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01006761170238404
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1557161477826483e-17,-3.9094704036568564e-18,3.409900535761637e-19)
    sum a = (2.2880135286396098e-17,-3.4659775050016606e-17,6.849989325763417e-18)
    sum e = 2.592000271178621
    sum de = 1.6805133673525319e-18
Info: CFL hydro = 0.005441215883793634 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005441215883793634 cfl multiplier : 0.4930218150262176        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4752e+04 |  512 |      1 | 3.471e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1119.5502962490943 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.26317550023788255, dt = 0.005441215883793634 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.5%)
   patch tree reduce : 1611.00 ns (0.6%)
   gen split merge   : 663.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 959.00 ns  (0.3%)
   LB compute        : 273.45 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.66 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1802.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2186540838954318e-17,-4.743032138918024e-18,6.22609873813379e-19)
    sum a = (1.3034885670837327e-16,4.2809505940155647e-17,6.559596615884899e-17)
    sum e = 2.5920008305747335
    sum de = 2.3445871979999033e-18
Info: CFL hydro = 0.007310412564965421 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007310412564965421 cfl multiplier : 0.6620145433508117        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0163e+04 |  512 |      1 | 2.539e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 771.4201194314412 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.2686167161216762, dt = 0.007310412564965421 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.4%)
   patch tree reduce : 1355.00 ns (0.5%)
   gen split merge   : 947.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1148.00 ns (0.4%)
   LB compute        : 282.44 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1913.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0848743778324454e-17,-4.213182537224358e-18,1.2093597607717998e-18)
    sum a = (-6.686057957283608e-17,3.391037450839462e-17,-4.358232524870331e-17)
    sum e = 2.592001294513008
    sum de = -1.328147661294743e-18
Info: CFL hydro = 0.008562580349498628 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008562580349498628 cfl multiplier : 0.7746763622338744        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9618e+04 |  512 |      1 | 2.610e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1008.3901801411189 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.2759271286866416, dt = 0.008562580349498628 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.69 us    (1.5%)
   patch tree reduce : 1326.00 ns (0.4%)
   gen split merge   : 685.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1274.00 ns (0.4%)
   LB compute        : 287.63 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1923079711040341e-17,-3.893370001395446e-18,3.5841690943297367e-19)
    sum a = (-7.215322089804132e-17,1.8538295898373747e-16,5.95597789837532e-17)
    sum e = 2.5920016593233544
    sum de = -1.883801274693564e-18
Info: CFL hydro = 0.009405537162061267 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009405537162061267 cfl multiplier : 0.8497842414892496        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9640e+04 |  512 |      1 | 2.607e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1182.4498265524473 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.28448970903614024, dt = 0.009405537162061267 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.5%)
   patch tree reduce : 1232.00 ns (0.4%)
   gen split merge   : 995.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 973.00 ns  (0.3%)
   LB compute        : 282.50 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1954.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2742736553439381e-17,-1.4182990719369126e-18,1.5141696490389433e-18)
    sum a = (-1.5737411374061593e-17,1.0126274818667014e-16,-5.992276987110134e-17)
    sum e = 2.5920018826781517
    sum de = -5.421010862427522e-20
Info: CFL hydro = 0.00995549115826959 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00995549115826959 cfl multiplier : 0.899856160992833          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9475e+04 |  512 |      1 | 2.629e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1287.9663645906908 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.2938952461982015, dt = 0.00995549115826959 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.99 us    (1.3%)
   patch tree reduce : 1251.00 ns (0.4%)
   gen split merge   : 728.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 914.00 ns  (0.3%)
   LB compute        : 293.22 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.64 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2772010012096491e-17,-1.015789015401669e-18,3.618931326485053e-19)
    sum a = (1.0943589784373486e-16,4.496403249731884e-18,9.150883176212155e-18)
    sum e = 2.592001954767734
    sum de = 3.3881317890172014e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011496128028069583
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2119211884042969e-17,-1.317305639569888e-18,7.000015801381098e-19)
    sum a = (-7.866363810338228e-17,-1.0098172298356189e-16,8.951823657343816e-18)
    sum e = 2.5920002253595547
    sum de = 3.2526065174565133e-19
Info: CFL hydro = 0.005133284117064253 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005133284117064253 cfl multiplier : 0.46661872033094437       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5026e+04 |  512 |      1 | 3.407e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1051.8420979270306 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.3038507373564711, dt = 0.005133284117064253 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.4%)
   patch tree reduce : 1239.00 ns (0.4%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 957.00 ns  (0.3%)
   LB compute        : 271.06 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.43 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1897.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3243312696475939e-17,-2.3477313843001113e-18,7.837968555440832e-19)
    sum a = (-8.149730890139039e-18,6.857014955841123e-17,3.480614234330215e-18)
    sum e = 2.592000687080069
    sum de = -3.1577388273640317e-18
Info: CFL hydro = 0.007068954389067947 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007068954389067947 cfl multiplier : 0.6444124802206296        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0044e+04 |  512 |      1 | 2.554e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 723.4395252559274 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.3089840214735354, dt = 0.007068954389067947 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 1565.00 ns (0.5%)
   gen split merge   : 678.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 905.00 ns  (0.3%)
   LB compute        : 276.84 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3533119937181315e-17,-1.5280745419010699e-18,8.317321440950987e-19)
    sum a = (2.510491814433635e-17,-8.945968965612394e-17,-4.439320005350522e-17)
    sum e = 2.592001019220096
    sum de = 1.9922214919421144e-18
Info: CFL hydro = 0.008338805770105616 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008338805770105616 cfl multiplier : 0.7629416534804196        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9183e+04 |  512 |      1 | 2.669e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 953.4400441199695 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.31605297586260334, dt = 0.008338805770105616 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1014.00 ns (0.4%)
   gen split merge   : 1008.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 863.00 ns  (0.3%)
   LB compute        : 272.99 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1892.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2997415643756227e-17,-2.7077949257825475e-18,2.510199079847064e-19)
    sum a = (-8.931917705456982e-17,-3.2692598628258907e-17,-2.5664041204687127e-17)
    sum e = 2.5920012150877585
    sum de = 1.6263032587282567e-19
Info: CFL hydro = 0.009167272663885045 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009167272663885045 cfl multiplier : 0.8419611023202798        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9321e+04 |  512 |      1 | 2.650e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1132.8066713083856 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.32439178163270893, dt = 0.009167272663885045 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1463.00 ns (0.5%)
   gen split merge   : 740.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 950.00 ns  (0.3%)
   LB compute        : 276.68 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.73 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1868.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4130298493786332e-17,-2.71657696337968e-18,6.074242671350039e-20)
    sum a = (-6.768023641523513e-18,3.6111738599409194e-17,-1.3240238983316943e-16)
    sum e = 2.5920012639314782
    sum de = -2.574980159653073e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011793722943672385
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.412444380205491e-17,-2.517517444511341e-18,-3.564043591502974e-19)
    sum a = (-2.4940986775856543e-17,-1.0571231390255065e-16,-1.2320759646897161e-16)
    sum e = 2.5920002113238985
    sum de = -1.6805133673525319e-18
Info: CFL hydro = 0.004854337028782759 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004854337028782759 cfl multiplier : 0.44732036744009324       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4672e+04 |  512 |      1 | 3.490e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 945.7128666243042 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.333559054296594, dt = 0.004854337028782759 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.5%)
   patch tree reduce : 1197.00 ns (0.4%)
   gen split merge   : 709.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 903.00 ns  (0.3%)
   LB compute        : 279.78 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1890.00 ns (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4349849433714644e-17,-3.6943104825271076e-18,-1.0044455501720394e-18)
    sum a = (6.002229963053551e-17,-1.0149693585592701e-16,5.1631062706475326e-17)
    sum e = 2.592000507833554
    sum de = 2.2497195079074217e-18
Info: CFL hydro = 0.006841911360931532 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006841911360931532 cfl multiplier : 0.6315469116267288        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9092e+04 |  512 |      1 | 2.682e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 651.6425104504478 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.33841339132537673, dt = 0.006841911360931532 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.06 us    (1.7%)
   patch tree reduce : 1551.00 ns (0.5%)
   gen split merge   : 750.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 916.00 ns  (0.3%)
   LB compute        : 284.81 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.47 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3650213771809749e-17,-4.361745339909184e-18,-2.6199745498112216e-19)
    sum a = (-1.0051334764504816e-16,-6.641562300124804e-17,8.269386152399971e-17)
    sum e = 2.5920007148170927
    sum de = -1.2739375526704677e-18
Info: CFL hydro = 0.008155800178359112 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008155800178359112 cfl multiplier : 0.7543646077511527        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9224e+04 |  512 |      1 | 2.663e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 924.7914234146153 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.3452553026863083, dt = 0.008155800178359112 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1328.00 ns (0.5%)
   gen split merge   : 898.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 946.00 ns  (0.3%)
   LB compute        : 275.85 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5131450779859444e-17,-5.011616122096995e-18,2.9053907717180303e-19)
    sum a = (7.636859894466496e-17,-3.447242491461111e-17,1.3958225444617514e-17)
    sum e = 2.5920008183751513
    sum de = -9.215718466126788e-19
Info: CFL hydro = 0.009023848240355311 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009023848240355311 cfl multiplier : 0.8362430718341018        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9640e+04 |  512 |      1 | 2.607e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1126.2748568364923 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.35341110286466737, dt = 0.009023848240355311 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.5%)
   patch tree reduce : 1705.00 ns (0.6%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 922.00 ns  (0.3%)
   LB compute        : 277.70 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.48 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1780.00 ns (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3500919132658496e-17,-4.99405204690273e-18,1.7527483370943786e-19)
    sum a = (-1.9297063946766003e-17,-1.4240952167510202e-16,-1.6186027127981783e-17)
    sum e = 2.592000824635907
    sum de = -1.4094628242311558e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011876688038906296
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3872692057603775e-17,-5.702469746404759e-18,2.3418766925686896e-20)
    sum a = (7.320706540969724e-17,-2.210731597784843e-17,-1.3947339377179403e-17)
    sum e = 2.5920002068398085
    sum de = -4.6349642873755315e-18
Info: CFL hydro = 0.004801193249208345 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004801193249208345 cfl multiplier : 0.44541435727803397       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4670e+04 |  512 |      1 | 3.490e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 930.8196314165483 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.36243495110502266, dt = 0.004801193249208345 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.2%)
   patch tree reduce : 1491.00 ns (0.4%)
   gen split merge   : 716.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 986.00 ns  (0.3%)
   LB compute        : 353.28 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 3.44 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.83 us    (74.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3094018057324686e-17,-5.1638381071139605e-18,1.0575036939880489e-19)
    sum a = (-2.292697282024747e-17,-2.5470250908377067e-16,-2.6596400862916037e-17)
    sum e = 2.5920003820397026
    sum de = 3.415236843329339e-18
Info: CFL hydro = 0.0067901477596944365 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0067901477596944365 cfl multiplier : 0.630276238185356        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9682e+04 |  512 |      1 | 2.601e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 664.4491458357135 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.367236144354231, dt = 0.0067901477596944365 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.84 us    (1.5%)
   patch tree reduce : 1191.00 ns (0.4%)
   gen split merge   : 1148.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 1128.00 ns (0.3%)
   LB compute        : 308.22 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1968.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3524337899584182e-17,-7.388620965054215e-18,-2.4114011568793224e-19)
    sum a = (3.0186790567210406e-17,1.765775026196792e-17,8.809261913683697e-17)
    sum e = 2.592000501362094
    sum de = 1.1655173354219173e-18
Info: CFL hydro = 0.008114656568074868 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008114656568074868 cfl multiplier : 0.7535174921235708        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9592e+04 |  512 |      1 | 2.613e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 935.3709236648082 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.37402629211392546, dt = 0.008114656568074868 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 1531.00 ns (0.5%)
   gen split merge   : 713.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 976.00 ns  (0.3%)
   LB compute        : 295.28 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1996.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3032543794144757e-17,-6.387468678981101e-18,8.77106005013617e-19)
    sum a = (2.3746629662646512e-17,8.844097329485657e-17,7.548454049322028e-17)
    sum e = 2.5920005675633973
    sum de = 3.6591823321385775e-18
Info: CFL hydro = 0.009000128384972878 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009000128384972878 cfl multiplier : 0.8356783280823805        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0186e+04 |  512 |      1 | 2.536e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1151.727208369711 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.3821409486820003, dt = 0.009000128384972878 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.5%)
   patch tree reduce : 13.89 us   (4.5%)
   gen split merge   : 745.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1664.00 ns (0.5%)
   LB compute        : 280.68 us  (90.4%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1967.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3102800094921819e-17,-5.456572693685047e-18,1.6554140870594924e-18)
    sum a = (4.067839814991814e-17,-9.372190523659896e-17,-8.33591008719825e-17)
    sum e = 2.592000597362002
    sum de = -1.8431436932253575e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011540492937965269
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2848121004604973e-17,-5.901529265273098e-18,9.239435388649908e-19)
    sum a = (-4.344181264714919e-17,-1.3407244064955747e-17,8.858148589641068e-18)
    sum e = 2.592000216687427
    sum de = -4.065758146820642e-18
Info: CFL hydro = 0.004800333412794241 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004800333412794241 cfl multiplier : 0.4452261093607935        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4459e+04 |  512 |      1 | 3.541e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 914.9666467194269 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.3911410770669732, dt = 0.004800333412794241 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.83 us    (1.5%)
   patch tree reduce : 1771.00 ns (0.6%)
   gen split merge   : 1457.00 ns (0.5%)
   split / merge op  : 0/0
   apply split merge : 972.00 ns  (0.3%)
   LB compute        : 299.41 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3064744598667577e-17,-5.749307280256133e-18,1.3959780597108672e-18)
    sum a = (3.4519262448462486e-17,-5.483504275649587e-17,7.191317853705304e-17)
    sum e = 2.592000323483892
    sum de = -4.174178364069192e-18
Info: CFL hydro = 0.006798353615385393 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006798353615385393 cfl multiplier : 0.6301507395738623        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9288e+04 |  512 |      1 | 2.655e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 651.001730386291 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 0.39594141047976744, dt = 0.006798353615385393 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.3%)
   patch tree reduce : 1693.00 ns (0.6%)
   gen split merge   : 715.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 915.00 ns  (0.3%)
   LB compute        : 286.32 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2692971673722298e-17,-6.481143746683848e-18,2.096345558082191e-18)
    sum a = (3.7270967562230696e-17,-1.317071451900631e-16,-9.982249402074039e-18)
    sum e = 2.592000424879412
    sum de = 1.0028870095490916e-18
Info: CFL hydro = 0.008138511706104133 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008138511706104133 cfl multiplier : 0.7534338263825747        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9451e+04 |  512 |      1 | 2.632e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 929.7724535687828 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.40273976409515283, dt = 0.008138511706104133 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.5%)
   patch tree reduce : 1523.00 ns (0.5%)
   gen split merge   : 682.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 791.00 ns  (0.3%)
   LB compute        : 268.06 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1972.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2530503978175344e-17,-7.652082092968194e-18,1.949429387446827e-18)
    sum a = (-2.3758339046109356e-17,-1.647510253222073e-16,1.1790178208737068e-16)
    sum e = 2.5920005234875805
    sum de = 7.209944447028604e-18
Info: CFL hydro = 0.009044523480579459 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009044523480579459 cfl multiplier : 0.8356225509217164        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0229e+04 |  512 |      1 | 2.531e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1157.5695058661813 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.41087827580125696, dt = 0.009044523480579459 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.69 us    (1.6%)
   patch tree reduce : 1393.00 ns (0.5%)
   gen split merge   : 725.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 906.00 ns  (0.3%)
   LB compute        : 271.65 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.283641162114213e-17,-9.262122319109167e-18,3.2892389983593673e-18)
    sum a = (-1.5096908098644057e-16,-9.770309561396573e-17,9.64267728165158e-18)
    sum e = 2.592000633568396
    sum de = -4.797594613248357e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011015025122765107
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3442372215344278e-17,-8.981097116000924e-18,2.8135452951813523e-18)
    sum a = (-2.01050114057022e-17,-6.463579671489583e-17,5.522730710250112e-17)
    sum e = 2.592000237786924
    sum de = -8.673617379884035e-19
Info: CFL hydro = 0.004828311068940634 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004828311068940634 cfl multiplier : 0.44520751697390554       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4937e+04 |  512 |      1 | 3.428e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 949.9342500143846 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.4199227992818364, dt = 0.004828311068940634 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.76 us    (1.4%)
   patch tree reduce : 1180.00 ns (0.3%)
   gen split merge   : 718.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 989.00 ns  (0.3%)
   LB compute        : 329.69 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.34 us    (70.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3042789504674746e-17,-9.127464409286467e-18,3.3047905232709564e-18)
    sum a = (-8.243405957841787e-17,-4.662676494904261e-17,-2.933786026615426e-17)
    sum e = 2.592000347202765
    sum de = -2.087089182034596e-18
Info: CFL hydro = 0.006836738664353909 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006836738664353909 cfl multiplier : 0.6301383446492704        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9900e+04 |  512 |      1 | 2.573e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 675.6024926662192 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.42475111035077706, dt = 0.006836738664353909 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1619.00 ns (0.5%)
   gen split merge   : 690.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 978.00 ns  (0.3%)
   LB compute        : 294.36 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3719006399653955e-17,-9.777335191474278e-18,3.006933081434876e-18)
    sum a = (-2.823132352891555e-17,-7.208296459726426e-17,3.768665067516164e-17)
    sum e = 2.592000499500209
    sum de = 4.607859233063394e-19
Info: CFL hydro = 0.008182067299972227 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008182067299972227 cfl multiplier : 0.7534255630995137        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9927e+04 |  512 |      1 | 2.569e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 957.9234713794798 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.431587849015131, dt = 0.008182067299972227 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.65 us    (1.4%)
   patch tree reduce : 1404.00 ns (0.4%)
   gen split merge   : 720.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1097.00 ns (0.3%)
   LB compute        : 307.79 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.40 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3577030125166978e-17,-1.0263274605182281e-17,3.5593781340294974e-18)
    sum a = (6.693083587361315e-17,7.538501073378611e-17,-6.699523748265879e-17)
    sum e = 2.592000679638782
    sum de = -2.371692252312041e-18
Info: CFL hydro = 0.009089508784566078 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009089508784566078 cfl multiplier : 0.8356170420663425        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8997e+04 |  512 |      1 | 2.695e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1092.9124635305545 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.4397699163151032, dt = 0.009089508784566078 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.5%)
   patch tree reduce : 1475.00 ns (0.5%)
   gen split merge   : 724.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 964.00 ns  (0.3%)
   LB compute        : 277.86 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.41 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1869.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2787378577891473e-17,-8.805456364058272e-18,2.2592134766967217e-18)
    sum a = (5.708909907309323e-17,-1.690834972034594e-17,-1.72479218407684e-17)
    sum e = 2.5920008873812277
    sum de = 1.395910297075087e-18
Info: CFL hydro = 0.009709123880991918 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009709123880991918 cfl multiplier : 0.8904113613775616        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9715e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1259.9783178541336 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.4488594250996693, dt = 0.009709123880991918 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.66 us    (1.6%)
   patch tree reduce : 1449.00 ns (0.5%)
   gen split merge   : 770.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 974.00 ns  (0.3%)
   LB compute        : 282.28 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.38 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.227216570552636e-17,-9.50801937182888e-18,2.470588431101664e-18)
    sum a = (-1.383112374631068e-16,1.9484414082171496e-16,-5.635726260666551e-17)
    sum e = 2.592001119455427
    sum de = -1.7753810574450135e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010923789740541038
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3284295538595891e-17,-8.547849927875717e-18,2.1394324300431226e-18)
    sum a = (-4.48176652040333e-17,-9.475233098132918e-17,-1.4507926110463033e-17)
    sum e = 2.592000293047987
    sum de = -1.8295911660692887e-18
Info: CFL hydro = 0.0050718147805103924 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0050718147805103924 cfl multiplier : 0.4634704537925205       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.3644e+04 |  512 |      1 | 3.753e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 931.4072911653338 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.45856854898066124, dt = 0.0050718147805103924 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1743.00 ns (0.6%)
   gen split merge   : 733.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 964.00 ns  (0.3%)
   LB compute        : 276.96 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2893494865523491e-17,-1.0397932515004981e-17,2.381761779989e-18)
    sum a = (5.866401114884567e-18,-2.2294666113253925e-17,5.920264278813647e-17)
    sum e = 2.5920005108230653
    sum de = -6.369687763352339e-19
Info: CFL hydro = 0.007042209632747818 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007042209632747818 cfl multiplier : 0.6423136358616803        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9613e+04 |  512 |      1 | 2.611e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 699.424606555936 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 0.4636403637611716, dt = 0.007042209632747818 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.5%)
   patch tree reduce : 1723.00 ns (0.5%)
   gen split merge   : 744.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 13.77 us   (4.3%)
   LB compute        : 288.37 us  (90.4%)
   LB move op cnt    : 0
   LB apply          : 3.75 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1999.00 ns (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.268565330905802e-17,-1.0280838680376547e-17,2.8914858788559037e-18)
    sum a = (-3.0066769386716264e-17,1.259929660601955e-17,1.1052487050577931e-16)
    sum e = 2.592000789208744
    sum de = 6.911788849595091e-19
Info: CFL hydro = 0.008366612576643026 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008366612576643026 cfl multiplier : 0.7615424239077869        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8906e+04 |  512 |      1 | 2.708e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 936.1313592673106 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.47068257339391945, dt = 0.008366612576643026 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.3%)
   patch tree reduce : 1552.00 ns (0.5%)
   gen split merge   : 749.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1302.00 ns (0.4%)
   LB compute        : 311.83 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.45 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3147442119373909e-17,-1.0046651011119678e-17,3.9270344788511215e-18)
    sum a = (1.1878291319294964e-16,-3.461293751616523e-17,9.580617549298509e-17)
    sum e = 2.5920010862867016
    sum de = 2.4936649967166602e-18
Info: CFL hydro = 0.009265305669221159 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009265305669221159 cfl multiplier : 0.8410282826051914        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8951e+04 |  512 |      1 | 2.702e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1114.8455779325361 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.47904918597056245, dt = 0.009265305669221159 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.89 us    (1.5%)
   patch tree reduce : 1867.00 ns (0.6%)
   gen split merge   : 725.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 981.00 ns  (0.3%)
   LB compute        : 302.07 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.47 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1944.00 ns (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1402012146943807e-17,-1.0497462274439151e-17,4.7620598870451445e-18)
    sum a = (-7.67333965532896e-18,-4.585394564049494e-17,1.199509241933683e-16)
    sum e = 2.5920013772080117
    sum de = 2.3852447794681098e-18
Info: CFL hydro = 0.009867641320215698 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009867641320215698 cfl multiplier : 0.8940188550701276        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9760e+04 |  512 |      1 | 2.591e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1287.2693022641697 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.48831449163978363, dt = 0.009867641320215698 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.5%)
   patch tree reduce : 1395.00 ns (0.5%)
   gen split merge   : 786.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 959.00 ns  (0.3%)
   LB compute        : 278.57 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1987.00 ns (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1986017647153125e-17,-1.113855101902983e-17,5.9509282267569685e-18)
    sum a = (-1.1733826800822134e-16,-6.730553614442414e-17,-1.6813503714296906e-16)
    sum e = 2.5920016375520687
    sum de = 1.6195269951502222e-18
Info: CFL hydro = 0.010267690020056616 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010267690020056616 cfl multiplier : 0.929345903380085         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9079e+04 |  512 |      1 | 2.684e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1323.7594121857721 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.49818213295999936, dt = 0.0018178670400006425 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.40 us    (1.8%)
   patch tree reduce : 1572.00 ns (0.5%)
   gen split merge   : 698.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 897.00 ns  (0.3%)
   LB compute        : 278.89 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1922.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.288398099145993e-17,-1.1252717507792553e-17,4.343815346481705e-18)
    sum a = (-1.5397839253639135e-17,7.91554322088217e-18,5.648606582475679e-17)
    sum e = 2.5920003821612663
    sum de = -1.5924219408380846e-18
Info: CFL hydro = 0.010531184240524016 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010531184240524016 cfl multiplier : 0.9528972689200567        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0048e+04 |  512 |      1 | 2.554e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 256.24782270535206 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 68                                                      [SPH][rank=0]
Info: time since start : 1731.608809239 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.1494501065853372 max=0.1505760093428771 delta=0.0011259027575399039
Number of particle pairs: 130816
Distance min=0.144958 max=1.992338 mean=0.806478
---------------- t = 0.5, dt = 0.010531184240524016 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.96 us    (1.6%)
   patch tree reduce : 1196.00 ns (0.2%)
   gen split merge   : 484.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 1609.00 ns (0.3%)
   LB compute        : 598.30 us  (96.0%)
   LB move op cnt    : 0
   LB apply          : 4.79 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (78.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2891299356124209e-17,-1.1126841635566986e-17,5.1894523834389304e-18)
    sum a = (-1.1132696327298408e-17,3.8640965427383376e-17,-5.756918379506981e-17)
    sum e = 2.5920018979833643
    sum de = 2.270048298641525e-19
Info: CFL hydro = 0.010692085486205493 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010692085486205493 cfl multiplier : 0.9685981792800377        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4541e+04 |  512 |      1 | 3.521e-02 | 0.1% |   2.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1076.7590580004614 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.510531184240524, dt = 0.010692085486205493 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.5%)
   patch tree reduce : 1606.00 ns (0.5%)
   gen split merge   : 740.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 13.77 us   (4.4%)
   LB compute        : 284.02 us  (90.6%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3129878044179643e-17,-1.052673573309626e-17,3.924838969451838e-18)
    sum a = (-3.056734552975282e-17,-1.0585282650410476e-16,-1.2061835905075036e-16)
    sum e = 2.592002037044251
    sum de = -4.743384504624082e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010104953805732236
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.327185431866662e-17,-1.1255644853658264e-17,3.509887692987323e-18)
    sum a = (1.529421120999297e-16,-2.1545265571631944e-17,-2.7926879558881622e-18)
    sum e = 2.5920003518808996
    sum de = -1.5543054582116411e-18
Info: CFL hydro = 0.005402482285006631 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005402482285006631 cfl multiplier : 0.48953272642667917       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4408e+04 |  512 |      1 | 3.554e-02 | 0.1% |   2.5% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1083.1659847970925 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.5212232697267295, dt = 0.005402482285006631 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.70 us    (1.5%)
   patch tree reduce : 1479.00 ns (0.5%)
   gen split merge   : 745.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1077.00 ns (0.3%)
   LB compute        : 292.27 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.123442159613186e-17,-1.0948273537758624e-17,4.221964574821491e-18)
    sum a = (1.5739753250754161e-16,4.088916705224932e-17,6.846476510724564e-17)
    sum e = 2.5920007758827515
    sum de = -7.496241583200558e-19
Info: CFL hydro = 0.0072795270165766065 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0072795270165766065 cfl multiplier : 0.6596884842844527       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8586e+04 |  512 |      1 | 2.755e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 706.0125145665743 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.5266257520117361, dt = 0.0072795270165766065 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.3%)
   patch tree reduce : 1413.00 ns (0.4%)
   gen split merge   : 742.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1177.00 ns (0.4%)
   LB compute        : 306.68 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0322553358962926e-17,-1.0323285195429355e-17,4.726199900190186e-18)
    sum a = (7.005138656646093e-17,6.557254739192331e-19,-6.178456184169345e-17)
    sum e = 2.5920011239638687
    sum de = -7.928228386300251e-19
Info: CFL hydro = 0.008532099833937167 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008532099833937167 cfl multiplier : 0.773125656189635         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9096e+04 |  512 |      1 | 2.681e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 977.4074440289266 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.5339052790283128, dt = 0.008532099833937167 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.4%)
   patch tree reduce : 1568.00 ns (0.5%)
   gen split merge   : 737.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1009.00 ns (0.3%)
   LB compute        : 310.72 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.39 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.80880415953067e-18,-1.058217234542816e-17,3.809940644222687e-18)
    sum a = (-2.645149724256335e-17,7.306655280814311e-18,-5.888063474290827e-17)
    sum e = 2.5920013951147687
    sum de = -2.442843019881402e-18
Info: CFL hydro = 0.009370805595837686 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009370805595837686 cfl multiplier : 0.8487504374597566        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8905e+04 |  512 |      1 | 2.708e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1134.112013377286 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.54243737886225, dt = 0.009370805595837686 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.4%)
   patch tree reduce : 1768.00 ns (0.6%)
   gen split merge   : 804.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 962.00 ns  (0.3%)
   LB compute        : 301.64 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1702.00 ns (62.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0516490022566272e-17,-1.0387686804474994e-17,3.1578743526355922e-18)
    sum a = (1.9644832635612452e-16,-9.034960279930004e-17,-3.606490106555782e-17)
    sum e = 2.5920015624839827
    sum de = 4.2012834183813297e-19
Info: CFL hydro = 0.009915284880026132 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009915284880026132 cfl multiplier : 0.8991669583065045        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9373e+04 |  512 |      1 | 2.643e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1276.4438688821954 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.5518081844580877, dt = 0.009915284880026132 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.3%)
   patch tree reduce : 1387.00 ns (0.5%)
   gen split merge   : 738.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 868.00 ns  (0.3%)
   LB compute        : 280.09 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.38 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1944.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.343247104135697e-18,-1.1677182658320629e-17,2.813911213414566e-18)
    sum a = (-1.0714085868501755e-16,1.9250226412914628e-17,-6.814275706201744e-17)
    sum e = 2.592001622915688
    sum de = 8.063753657860939e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01120534444191854
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.708853950489815e-18,-1.1101959195708443e-17,2.8051291758174335e-18)
    sum a = (1.2037246199803065e-16,-2.8102520310824274e-17,2.7657563739236224e-17)
    sum e = 2.592000324817951
    sum de = -1.3552527156068805e-20
Info: CFL hydro = 0.0051392367978496615 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0051392367978496615 cfl multiplier : 0.46638898610216817      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4189e+04 |  512 |      1 | 3.609e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 989.1913311400358 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.5617234693381138, dt = 0.0051392367978496615 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1236.00 ns (0.4%)
   gen split merge   : 668.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 994.00 ns  (0.3%)
   LB compute        : 284.01 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.3037279349486e-18,-1.1584971263550735e-17,3.5281836046480164e-18)
    sum a = (1.1358101958958143e-16,-8.960020225767806e-17,-7.17433924768418e-17)
    sum e = 2.5920006738585752
    sum de = -7.995991022080595e-19
Info: CFL hydro = 0.007096719563111786 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007096719563111786 cfl multiplier : 0.6442593240681121        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0197e+04 |  512 |      1 | 2.535e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 729.8174740501884 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.5668627061359635, dt = 0.007096719563111786 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.75 us    (1.6%)
   patch tree reduce : 1990.00 ns (0.7%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 967.00 ns  (0.3%)
   LB compute        : 278.61 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.41 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.602628600110849e-18,-1.2389991376621224e-17,2.4157921756778887e-18)
    sum a = (-2.896901468707469e-17,-5.803170444185213e-17,6.511880878273813e-17)
    sum e = 2.592000936647684
    sum de = 2.6156377411212794e-18
Info: CFL hydro = 0.008401055190231824 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008401055190231824 cfl multiplier : 0.7628395493787415        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8767e+04 |  512 |      1 | 2.728e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 936.470420877872 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 0.5739594256990752, dt = 0.008401055190231824 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 2.16 us    (0.7%)
   gen split merge   : 756.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1031.00 ns (0.3%)
   LB compute        : 288.67 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 4.04 us    (1.3%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1880.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.069540265691731e-18,-1.2757373282767936e-17,3.351811016238937e-18)
    sum a = (7.943645741192995e-17,-1.9475046575401223e-16,-5.921727951746503e-17)
    sum e = 2.5920011068328557
    sum de = -2.236166980751353e-18
Info: CFL hydro = 0.009250437354603276 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009250437354603276 cfl multiplier : 0.8418930329191611        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9901e+04 |  512 |      1 | 2.573e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1175.5436735158194 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.582360480889307, dt = 0.009250437354603276 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.79 us    (1.6%)
   patch tree reduce : 1522.00 ns (0.5%)
   gen split merge   : 693.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 923.00 ns  (0.3%)
   LB compute        : 286.90 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1904.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.1649903931870755e-18,-1.5160724238516554e-17,2.407741974547184e-18)
    sum a = (-1.3889670663624898e-16,-9.620429453072177e-17,-4.1694187165319805e-17)
    sum e = 2.5920011710543225
    sum de = 1.0842021724855044e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010807455892812946
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.021239058907503e-18,-1.467185747894284e-17,2.62363373214336e-18)
    sum a = (1.0819470319667346e-17,-7.653253031314478e-17,2.5623058362567174e-17)
    sum e = 2.592000317734102
    sum de = 3.1170812458958252e-18
Info: CFL hydro = 0.0048997743151113484 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0048997743151113484 cfl multiplier : 0.44729767763972034      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4835e+04 |  512 |      1 | 3.451e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 964.9020989850546 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.5916109182439103, dt = 0.0048997743151113484 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.5%)
   patch tree reduce : 1590.00 ns (0.5%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1051.00 ns (0.3%)
   LB compute        : 302.91 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1941.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.3450221639282934e-18,-1.5307091531802096e-17,3.1425057868406104e-18)
    sum a = (-1.6492666607414997e-16,-7.681355551625302e-17,-3.041805089060157e-17)
    sum e = 2.5920005572277747
    sum de = -2.5614276324970042e-18
Info: CFL hydro = 0.006906989908305247 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006906989908305247 cfl multiplier : 0.6315317850931469        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9297e+04 |  512 |      1 | 2.653e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 664.8251042889095 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.5965106925590217, dt = 0.006906989908305247 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.4%)
   patch tree reduce : 1554.00 ns (0.5%)
   gen split merge   : 1086.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1007.00 ns (0.3%)
   LB compute        : 316.29 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.839432228373688e-18,-1.5763757486852993e-17,2.775123880693897e-18)
    sum a = (-1.220586132166801e-16,-3.9765066239816346e-17,-7.763906705038347e-17)
    sum e = 2.5920007406026238
    sum de = 1.1655173354219173e-18
Info: CFL hydro = 0.008234549815059226 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008234549815059226 cfl multiplier : 0.7543545233954312        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9679e+04 |  512 |      1 | 2.602e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 955.7242439449948 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.603417682467327, dt = 0.008234549815059226 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1521.00 ns (0.5%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1041.00 ns (0.3%)
   LB compute        : 285.55 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.55 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.64298866851132e-18,-1.5608608155970316e-17,2.052801288329742e-18)
    sum a = (1.0022061305847707e-16,-2.6299275257546382e-17,2.597141252058677e-17)
    sum e = 2.5920008529201315
    sum de = -7.995991022080595e-19
Info: CFL hydro = 0.00911194100822674 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00911194100822674 cfl multiplier : 0.8362363489302874         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0010e+04 |  512 |      1 | 2.559e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1158.581459135541 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.6116522322823862, dt = 0.00911194100822674 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.5%)
   patch tree reduce : 1571.00 ns (0.5%)
   gen split merge   : 764.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1129.00 ns (0.4%)
   LB compute        : 274.11 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1846.00 ns (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.795833427247766e-18,-1.6208714058441042e-17,2.70047656111827e-18)
    sum a = (-1.7411853209248207e-17,-3.8055496254241206e-17,2.6881085248356417e-17)
    sum e = 2.592000897373693
    sum de = 4.607859233063394e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011189854858766638
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.35788383346425e-18,-1.6217496096038177e-17,2.7121859445811136e-18)
    sum a = (-1.1123914289701275e-17,8.824191377598823e-17,-3.6130766347536314e-17)
    sum e = 2.592000318294938
    sum de = -4.336808689942018e-19
Info: CFL hydro = 0.004848159937683043 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004848159937683043 cfl multiplier : 0.44541211631009575       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4373e+04 |  512 |      1 | 3.562e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 920.8351941478917 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.620764173290613, dt = 0.004848159937683043 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.5%)
   patch tree reduce : 1324.00 ns (0.4%)
   gen split merge   : 729.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 285.90 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.78 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (64.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.26859978456007e-18,-1.5406621291236266e-17,2.1106163691775313e-18)
    sum a = (1.944460217839783e-16,-6.6040922730437045e-18,7.577068855159353e-17)
    sum e = 2.5920004815304303
    sum de = -2.791820594150174e-18
Info: CFL hydro = 0.006856623185041135 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006856623185041135 cfl multiplier : 0.6302747442067305        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9873e+04 |  512 |      1 | 2.576e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 677.4361325800465 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.625612333228296, dt = 0.006856623185041135 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.56 us    (1.4%)
   patch tree reduce : 1269.00 ns (0.4%)
   gen split merge   : 677.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 304.90 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.36 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.715642802800458e-18,-1.5269036035547855e-17,2.8190340686795602e-18)
    sum a = (-1.470698562933137e-17,-1.1660204052299505e-16,-9.54607486808312e-18)
    sum e = 2.592000615852732
    sum de = -1.4094628242311558e-18
Info: CFL hydro = 0.008193895506803793 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008193895506803793 cfl multiplier : 0.7535164961378203        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9968e+04 |  512 |      1 | 2.564e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 962.6538130851739 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.6324689564133371, dt = 0.008193895506803793 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1416.00 ns (0.5%)
   gen split merge   : 713.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 874.00 ns  (0.3%)
   LB compute        : 285.11 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.36 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.5572547391923305e-18,-1.6990315404585843e-17,2.6507116814011854e-18)
    sum a = (2.915636482248019e-17,-1.1429529198081488e-16,-2.7635425686126784e-17)
    sum e = 2.5920007151807387
    sum de = 1.3552527156068805e-18
Info: CFL hydro = 0.009087377189823461 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009087377189823461 cfl multiplier : 0.8356776640918803        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9886e+04 |  512 |      1 | 2.575e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1145.6830402147182 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.6406628519201409, dt = 0.009087377189823461 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1768.00 ns (0.6%)
   gen split merge   : 698.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1444.00 ns (0.5%)
   LB compute        : 287.28 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.974712911915869e-18,-1.7886083239493367e-17,2.196973072216002e-18)
    sum a = (6.461823263970157e-17,-1.6492666607414996e-17,-8.243950261213693e-17)
    sum e = 2.5920007883572787
    sum de = -1.7076184216646695e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011205615667291544
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.7200338215990246e-18,-1.738843444232252e-17,2.065242508259013e-18)
    sum a = (-9.590570525241926e-17,-6.639220423432235e-17,-1.375875426773681e-16)
    sum e = 2.5920003288636093
    sum de = -2.4123498337802474e-18
Info: CFL hydro = 0.004846046788455702 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004846046788455702 cfl multiplier : 0.44522588803062674       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4707e+04 |  512 |      1 | 3.481e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 939.6904705183952 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.6497502291099644, dt = 0.004846046788455702 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.4%)
   patch tree reduce : 1566.00 ns (0.5%)
   gen split merge   : 713.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 941.00 ns  (0.3%)
   LB compute        : 291.28 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1902.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.095886378483129e-18,-1.824029208924438e-17,1.18850242147861e-18)
    sum a = (2.9220766431525825e-17,1.9232662337720364e-18,6.163773715061639e-17)
    sum e = 2.592000457537717
    sum de = -1.4907779871675686e-18
Info: CFL hydro = 0.006862457099014257 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006862457099014257 cfl multiplier : 0.6301505920204179        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0114e+04 |  512 |      1 | 2.545e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 685.3576666337927 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.6545962758984201, dt = 0.006862457099014257 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.3%)
   patch tree reduce : 1278.00 ns (0.4%)
   gen split merge   : 706.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1361.00 ns (0.4%)
   LB compute        : 310.16 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.34 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.364049912055414e-18,-1.779826286352204e-17,2.2233191850073996e-18)
    sum a = (1.13463925754953e-16,9.668730659856406e-17,-1.1374293840777857e-16)
    sum e = 2.5920005938199098
    sum de = -2.7376104855258987e-18
Info: CFL hydro = 0.008210794760885851 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008210794760885851 cfl multiplier : 0.753433728013612         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9623e+04 |  512 |      1 | 2.609e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 946.8584151499873 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.6614587329974343, dt = 0.008210794760885851 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.6%)
   patch tree reduce : 1239.00 ns (0.4%)
   gen split merge   : 1073.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 921.00 ns  (0.3%)
   LB compute        : 278.21 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.0994364980683214e-18,-1.6720999584940442e-17,6.118152859335701e-19)
    sum a = (8.649136094829312e-17,-1.7273682484386653e-16,-8.024916180789793e-17)
    sum e = 2.5920007280113855
    sum de = 3.2526065174565133e-19
Info: CFL hydro = 0.009099578968120125 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009099578968120125 cfl multiplier : 0.8356224853424079        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9692e+04 |  512 |      1 | 2.600e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1136.884565470057 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.6696695277583201, dt = 0.009099578968120125 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.4%)
   patch tree reduce : 1639.00 ns (0.6%)
   gen split merge   : 700.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 892.00 ns  (0.3%)
   LB compute        : 274.31 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.70 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.197813971429376e-18,-1.94580679693801e-17,2.634611279139776e-19)
    sum a = (-2.3236539645546396e-17,1.1058341742309352e-16,-8.881741167727532e-17)
    sum e = 2.5920008625999027
    sum de = 0
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011118130176805447
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.6515525806145595e-18,-1.8158326405004476e-17,2.927345865710862e-20)
    sum a = (-7.972114179737033e-17,6.108785352565427e-17,-8.92845063019728e-17)
    sum e = 2.592000346122699
    sum de = 9.75781955236954e-19
Info: CFL hydro = 0.004848070715209562 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004848070715209562 cfl multiplier : 0.445207495114136         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4856e+04 |  512 |      1 | 3.446e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 950.5135922691363 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.6787691067264402, dt = 0.004848070715209562 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.4%)
   patch tree reduce : 1186.00 ns (0.4%)
   gen split merge   : 654.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 774.00 ns  (0.3%)
   LB compute        : 272.65 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.47 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.494628189939288e-18,-1.8281274931364334e-17,-5.357042934250877e-19)
    sum a = (1.100205437008523e-16,1.7322861894930596e-16,7.377862968997728e-17)
    sum e = 2.5920004894582798
    sum de = -4.743384504624082e-18
Info: CFL hydro = 0.00686202726450336 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00686202726450336 cfl multiplier : 0.6301383300760907         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0324e+04 |  512 |      1 | 2.519e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 692.8077379691441 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.6836171774416497, dt = 0.00686202726450336 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.5%)
   patch tree reduce : 1247.00 ns (0.4%)
   gen split merge   : 750.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1336.00 ns (0.4%)
   LB compute        : 281.46 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.24465150528075e-18,-1.6562922908192056e-17,5.108218535665454e-19)
    sum a = (-1.301966347233563e-16,-1.1763246626772529e-16,-5.1615694140680343e-17)
    sum e = 2.5920006704625216
    sum de = 1.4094628242311558e-18
Info: CFL hydro = 0.008207330095276502 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008207330095276502 cfl multiplier : 0.7534255533840604        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9569e+04 |  512 |      1 | 2.616e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 944.169758175833 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 0.6904792047061531, dt = 0.008207330095276502 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.5%)
   patch tree reduce : 1783.00 ns (0.6%)
   gen split merge   : 718.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1031.00 ns (0.4%)
   LB compute        : 275.06 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.1562083555899426e-18,-1.8497898525426937e-17,-2.927345865710862e-19)
    sum a = (3.5991717418915045e-17,-1.9297063946766003e-17,2.629305464758175e-17)
    sum e = 2.592000864452772
    sum de = 1.6805133673525319e-18
Info: CFL hydro = 0.009110255710768286 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009110255710768286 cfl multiplier : 0.8356170355893736        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8880e+04 |  512 |      1 | 2.712e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1089.5404292508447 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.6986865348014296, dt = 0.009110255710768286 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.88 us    (1.6%)
   patch tree reduce : 1713.00 ns (0.6%)
   gen split merge   : 745.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 947.00 ns  (0.3%)
   LB compute        : 279.70 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.234094407891021e-18,-1.830762104415573e-17,3.5713619561672516e-19)
    sum a = (-5.831272964496037e-18,1.9320482713691688e-17,-1.1695478569981322e-17)
    sum e = 2.59200106370136
    sum de = -1.4772254600114998e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010405686110879395
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.33069682145948e-18,-1.8222728014050115e-17,1.2148485342700078e-19)
    sum a = (8.482862849656935e-17,3.983532254059341e-17,6.294964549624637e-17)
    sum e = 2.5920003631277035
    sum de = -3.8624702394796095e-18
Info: CFL hydro = 0.0048621207947845795 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0048621207947845795 cfl multiplier : 0.44520567852979126      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4577e+04 |  512 |      1 | 3.512e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 933.7286648238738 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.7077967905121979, dt = 0.0048621207947845795 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.95 us    (1.7%)
   patch tree reduce : 1807.00 ns (0.6%)
   gen split merge   : 681.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1041.00 ns (0.4%)
   LB compute        : 276.90 us  (93.7%)
   LB move op cnt    : 0
   LB apply          : 3.84 us    (1.3%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.1743952045036894e-18,-1.790071996882192e-17,5.386316392907986e-19)
    sum a = (-1.2831727867756993e-16,1.0943589784373486e-16,-2.4793155809638146e-17)
    sum e = 2.592000558850455
    sum de = -1.328147661294743e-18
Info: CFL hydro = 0.0068882291723045665 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0068882291723045665 cfl multiplier : 0.6301371190198609       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9027e+04 |  512 |      1 | 2.691e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 650.4738093440403 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.7126589113069824, dt = 0.0068882291723045665 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.4%)
   patch tree reduce : 1171.00 ns (0.4%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1010.00 ns (0.3%)
   LB compute        : 293.27 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.996668005908701e-18,-1.6829311381971744e-17,3.322537557581828e-19)
    sum a = (-1.1238666247637142e-16,1.5784248907912968e-17,1.6384354810383694e-17)
    sum e = 2.5920008035455013
    sum de = 4.065758146820642e-18
Info: CFL hydro = 0.008249170319885209 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008249170319885209 cfl multiplier : 0.7534247460132407        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9334e+04 |  512 |      1 | 2.648e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 936.4075347506151 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.719547140479287, dt = 0.008249170319885209 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.2%)
   patch tree reduce : 1663.00 ns (0.5%)
   gen split merge   : 642.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1086.00 ns (0.3%)
   LB compute        : 321.83 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (69.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.602628600110849e-18,-1.7139610043737098e-17,4.874030866408585e-19)
    sum a = (-2.682619751337434e-17,2.857089564933801e-17,2.520152055790481e-17)
    sum e = 2.592001054883388
    sum de = 1.4365678785432934e-18
Info: CFL hydro = 0.009170284244962381 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009170284244962381 cfl multiplier : 0.8356164973421606        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9710e+04 |  512 |      1 | 2.598e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1143.2377768212657 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.7277963107991723, dt = 0.009170284244962381 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.4%)
   patch tree reduce : 1503.00 ns (0.5%)
   gen split merge   : 797.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1157.00 ns (0.4%)
   LB compute        : 294.16 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1943.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.6040922730437045e-18,-1.690542237448023e-17,8.020927672047761e-19)
    sum a = (-1.857108217206971e-17,-1.5409548637101976e-17,9.719373743333203e-17)
    sum e = 2.5920012917813944
    sum de = 6.2341624917916505e-19
Info: CFL hydro = 0.009801350395668975 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009801350395668975 cfl multiplier : 0.8904109982281071        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9415e+04 |  512 |      1 | 2.637e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1251.850425797382 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.7369665950441346, dt = 0.009801350395668975 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.98 us    (1.5%)
   patch tree reduce : 1473.00 ns (0.4%)
   gen split merge   : 912.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1106.00 ns (0.3%)
   LB compute        : 322.16 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.817788521240598e-18,-1.7313787122746892e-17,2.235028568470243e-18)
    sum a = (2.51985932120391e-17,-1.596223153654819e-16,-5.108218535665454e-17)
    sum e = 2.5920015012377724
    sum de = 6.2341624917916505e-19
Info: CFL hydro = 0.0102413407003413 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0102413407003413 cfl multiplier : 0.9269406654854047          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9225e+04 |  512 |      1 | 2.663e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1324.908410654067 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.7467679454398036, dt = 0.0102413407003413 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.84 us    (1.5%)
   patch tree reduce : 1413.00 ns (0.5%)
   gen split merge   : 855.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1011.00 ns (0.3%)
   LB compute        : 295.48 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.366977257921125e-18,-1.9623463010792762e-17,8.547849927875717e-19)
    sum a = (8.119286493135646e-17,2.3184579256430027e-17,8.509794431621476e-17)
    sum e = 2.5920016732678874
    sum de = 1.734723475976807e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011141340728125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.090343073611448e-18,-1.8777460055602323e-17,1.6085765532081186e-18)
    sum a = (-7.14740766571964e-17,-1.5077002146757223e-16,3.553797880972986e-17)
    sum e = 2.5920004082766446
    sum de = -1.9244588561617704e-18
Info: CFL hydro = 0.005253255998179748 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005253255998179748 cfl multiplier : 0.47564688849513487       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4449e+04 |  512 |      1 | 3.543e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1040.4826243672046 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.757009286140145, dt = 0.005253255998179748 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.3%)
   patch tree reduce : 1434.00 ns (0.4%)
   gen split merge   : 724.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1247.00 ns (0.4%)
   LB compute        : 324.98 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.71 us    (73.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.406185040248481e-18,-2.0333344383227647e-17,1.4241537636683344e-18)
    sum a = (-1.4470456083381933e-16,1.3817072486155268e-17,7.568945470382004e-17)
    sum e = 2.5920007355603962
    sum de = 8.809142651444724e-20
Info: CFL hydro = 0.007182416512720838 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007182416512720838 cfl multiplier : 0.6504312589967566        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9244e+04 |  512 |      1 | 2.661e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 710.801301705884 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 0.7622625421383247, dt = 0.007182416512720838 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1483.00 ns (0.5%)
   gen split merge   : 747.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1125.00 ns (0.4%)
   LB compute        : 293.94 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.38 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.496621375225776e-18,-1.9689328292771258e-17,2.196973072216002e-18)
    sum a = (9.878035889254732e-17,-1.1564187107904189e-16,-3.696066890046534e-17)
    sum e = 2.592001037993931
    sum de = -1.179069862577986e-18
Info: CFL hydro = 0.008469036535233853 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008469036535233853 cfl multiplier : 0.7669541726645045        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9754e+04 |  512 |      1 | 2.592e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 997.6024562901949 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.7694449586510456, dt = 0.008469036535233853 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.4%)
   patch tree reduce : 1381.00 ns (0.5%)
   gen split merge   : 966.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 987.00 ns  (0.3%)
   LB compute        : 286.20 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1910.00 ns (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.727040799403561e-18,-2.1184104275449865e-17,1.610040226140974e-18)
    sum a = (1.9828669955979095e-16,7.910859467497034e-17,-3.902737508165721e-17)
    sum e = 2.592001291905273
    sum de = 1.565316886525947e-18
Info: CFL hydro = 0.009329655956266222 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009329655956266222 cfl multiplier : 0.8446361151096697        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0137e+04 |  512 |      1 | 2.543e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1199.1377877190998 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.7779139951862795, dt = 0.009329655956266222 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 1379.00 ns (0.5%)
   gen split merge   : 1072.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 890.00 ns  (0.3%)
   LB compute        : 289.11 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.62 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.538849764784692e-18,-1.98363588128545e-17,1.2309489365314175e-18)
    sum a = (4.587736440742063e-17,-1.2786646741425044e-17,8.253358933785204e-17)
    sum e = 2.592001471874416
    sum de = -1.6195269951502222e-18
Info: CFL hydro = 0.009908853959285506 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009908853959285506 cfl multiplier : 0.8964240767397799        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9858e+04 |  512 |      1 | 2.578e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1302.6868244301183 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.7872436511425457, dt = 0.009908853959285506 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.72 us    (1.5%)
   patch tree reduce : 1365.00 ns (0.4%)
   gen split merge   : 627.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1211.00 ns (0.4%)
   LB compute        : 289.18 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.8352435336879165e-18,-2.0479345758279975e-17,2.5892374182212573e-18)
    sum a = (9.306617976267973e-17,8.018585795355193e-17,1.031947964580393e-16)
    sum e = 2.592001574412045
    sum de = -4.54009659728305e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010615279310974278
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.4510293888133656e-18,-2.0126234663228605e-17,2.4794619482571e-18)
    sum a = (-5.011616122096996e-17,4.64628335805628e-17,-4.2188908616624945e-17)
    sum e = 2.592000397446506
    sum de = -2.284447858744848e-18
Info: CFL hydro = 0.005152608911468881 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005152608911468881 cfl multiplier : 0.4654746922465933        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5017e+04 |  512 |      1 | 3.409e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1046.2550744790005 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.7971525051018312, dt = 0.005152608911468881 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.88 us    (1.4%)
   patch tree reduce : 1189.00 ns (0.4%)
   gen split merge   : 684.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 881.00 ns  (0.3%)
   LB compute        : 270.22 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.06 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1942.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.456572693685047e-18,-1.9761048266481173e-17,1.7212793690379868e-18)
    sum a = (1.9114397564745644e-16,8.02326954874033e-17,-4.812556603228657e-18)
    sum e = 2.59200071438077
    sum de = 3.877822711648594e-21
Info: CFL hydro = 0.007130350776273842 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007130350776273842 cfl multiplier : 0.6436497948310622        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0319e+04 |  512 |      1 | 2.520e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 736.1308923023453 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.8023051140133001, dt = 0.007130350776273842 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.02 us    (1.3%)
   patch tree reduce : 1217.00 ns (0.4%)
   gen split merge   : 699.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 996.00 ns  (0.3%)
   LB compute        : 289.71 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.29 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.487017803411457e-18,-1.9050435057579862e-17,1.6115038990738295e-18)
    sum a = (-2.0512497950209152e-16,2.3699792128795137e-17,4.939017944627366e-17)
    sum e = 2.5920009754000373
    sum de = -1.3772755722354924e-18
Info: CFL hydro = 0.008457024108943202 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008457024108943202 cfl multiplier : 0.7624331965540415        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0749e+04 |  512 |      1 | 2.468e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1040.2588407960234 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.809435464789574, dt = 0.008457024108943202 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.5%)
   patch tree reduce : 1231.00 ns (0.4%)
   gen split merge   : 1211.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 938.00 ns  (0.3%)
   LB compute        : 296.04 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.43 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.845781266081458e-18,-1.93234100595574e-17,2.4238423768085935e-18)
    sum a = (-7.025630077706068e-19,-5.798486690800076e-17,4.073694506723235e-17)
    sum e = 2.5920011646102554
    sum de = 4.875521644395753e-18
Info: CFL hydro = 0.00931063709830086 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00931063709830086 cfl multiplier : 0.8416221310360278         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0249e+04 |  512 |      1 | 2.529e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1204.080856053896 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.8178924888985172, dt = 0.00931063709830086 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.87 us    (1.4%)
   patch tree reduce : 1107.00 ns (0.4%)
   gen split merge   : 725.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 799.00 ns  (0.3%)
   LB compute        : 261.92 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.29 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (64.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.8649374419517116e-18,-2.004646448838798e-17,2.9288095386437175e-18)
    sum a = (-3.601806353170644e-17,-2.9367133724811365e-17,3.0725422206501207e-17)
    sum e = 2.592001259199882
    sum de = 1.565316886525947e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010463261835322165
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.9637353649194534e-18,-1.9958644112416655e-17,2.7224316551111016e-18)
    sum a = (-3.4378749846908365e-17,-1.5283087295703268e-16,-3.8594127893532006e-17)
    sum e = 2.592000390703113
    sum de = 7.589415207398531e-19
Info: CFL hydro = 0.00493525317431965 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00493525317431965 cfl multiplier : 0.4472073770120093         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5209e+04 |  512 |      1 | 3.366e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 995.6815625048079 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.827203125996818, dt = 0.00493525317431965 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.5%)
   patch tree reduce : 1129.00 ns (0.4%)
   gen split merge   : 714.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 841.00 ns  (0.3%)
   LB compute        : 263.28 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.31 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.217316700536657e-18,-2.1284731789583678e-17,2.196973072216002e-18)
    sum a = (5.601769048624306e-17,8.402653572936459e-17,6.62165634823797e-17)
    sum e = 2.5920006342273756
    sum de = 3.449118161219511e-18
Info: CFL hydro = 0.006959935784650185 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006959935784650185 cfl multiplier : 0.6314715846746729        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0744e+04 |  512 |      1 | 2.468e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 719.8268674479533 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.8321383791711376, dt = 0.006959935784650185 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.5%)
   patch tree reduce : 1026.00 ns (0.4%)
   gen split merge   : 1013.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 897.00 ns  (0.3%)
   LB compute        : 261.01 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.68 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.68929669000906e-18,-2.0295288886973406e-17,2.723895328043957e-18)
    sum a = (3.3582511771435005e-17,3.590096969707801e-17,-1.334869714764153e-18)
    sum e = 2.5920008357005315
    sum de = 1.3145951341386741e-18
Info: CFL hydro = 0.008301303531821291 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008301303531821291 cfl multiplier : 0.7543143897831154        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0467e+04 |  512 |      1 | 2.502e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1001.6011865478101 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.8390983149557878, dt = 0.008301303531821291 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.5%)
   patch tree reduce : 1368.00 ns (0.5%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 929.00 ns  (0.3%)
   LB compute        : 271.35 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.00 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.2626360300817024e-18,-1.9581016495739957e-17,2.6302202603412094e-18)
    sum a = (2.51985932120391e-17,-2.098321516541546e-17,1.5795958291375812e-17)
    sum e = 2.5920009716530226
    sum de = 3.347474207548995e-18
Info: CFL hydro = 0.009189634447877593 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009189634447877593 cfl multiplier : 0.8362095931887437        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9777e+04 |  512 |      1 | 2.589e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1154.3500115825025 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.8473996184876091, dt = 0.009189634447877593 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.5%)
   patch tree reduce : 1518.00 ns (0.5%)
   gen split merge   : 836.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1066.00 ns (0.4%)
   LB compute        : 278.96 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1862.00 ns (64.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.944287167185646e-18,-2.0535331247961697e-17,2.6873035047225714e-18)
    sum a = (5.484675213995871e-17,7.82655190656456e-17,8.049030192358585e-17)
    sum e = 2.592001038013804
    sum de = -5.421010862427522e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010906009086540361
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.727663573123042e-18,-2.0113793443299332e-17,2.982965437159368e-18)
    sum a = (8.852293897909646e-18,-3.009311549950766e-17,-7.27152713042578e-17)
    sum e = 2.592000388979975
    sum de = -6.911788849595091e-19
Info: CFL hydro = 0.00489074158196557 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00489074158196557 cfl multiplier : 0.4454031977295812         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4608e+04 |  512 |      1 | 3.505e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 943.8785614540294 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.8565892529354867, dt = 0.00489074158196557 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1482.00 ns (0.5%)
   gen split merge   : 643.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1669.00 ns (0.5%)
   LB compute        : 297.07 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.794992528034392e-18,-2.0684625887112952e-17,1.926193579637747e-18)
    sum a = (1.7020759801589235e-16,-4.6369158512860054e-18,-6.393323370712522e-17)
    sum e = 2.5920005721066355
    sum de = 2.3987973066241786e-18
Info: CFL hydro = 0.006916617645906706 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006916617645906706 cfl multiplier : 0.6302687984863874        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9321e+04 |  512 |      1 | 2.650e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 664.4166955789536 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.8614799945174523, dt = 0.006916617645906706 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1379.00 ns (0.5%)
   gen split merge   : 734.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 950.00 ns  (0.3%)
   LB compute        : 277.02 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.621126835884336e-18,-2.078708299241283e-17,1.6041855344095523e-18)
    sum a = (6.679032327205903e-17,-2.482389294122811e-17,-1.2703510118838857e-16)
    sum e = 2.592000726449551
    sum de = 2.303929616531697e-19
Info: CFL hydro = 0.00826429538295597 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00826429538295597 cfl multiplier : 0.7535125323242582         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9696e+04 |  512 |      1 | 2.599e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 957.8707576705273 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.868396612163359, dt = 0.00826429538295597 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1085.00 ns (0.4%)
   gen split merge   : 645.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 913.00 ns  (0.3%)
   LB compute        : 286.70 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.65 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1833.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.3840118207617564e-18,-2.0807574413472807e-17,2.254056316597364e-19)
    sum a = (2.7634144972310537e-17,1.048106913759117e-16,2.2400050564419514e-17)
    sum e = 2.5920008386826705
    sum de = -2.913793338554793e-18
Info: CFL hydro = 0.009162369982621118 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009162369982621118 cfl multiplier : 0.8356750215495055        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0068e+04 |  512 |      1 | 2.551e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1166.10825744497 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 0.8766609075463149, dt = 0.009162369982621118 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.77 us    (1.5%)
   patch tree reduce : 1254.00 ns (0.4%)
   gen split merge   : 734.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1054.00 ns (0.3%)
   LB compute        : 293.32 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.161533534967731e-18,-1.973616582662263e-17,1.1767930380157664e-18)
    sum a = (-1.2411946470614055e-17,2.0257233390719165e-17,2.5883592144615443e-16)
    sum e = 2.5920009119879155
    sum de = 2.710505431213761e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01126255838694075
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.1527514973705984e-18,-1.9788858052205428e-17,2.1984367451488575e-18)
    sum a = (-1.4215191523891945e-16,3.6228832434037626e-17,2.0608514894604467e-17)
    sum e = 2.592000394994408
    sum de = 2.8324781756183803e-18
Info: CFL hydro = 0.0048829680594325905 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0048829680594325905 cfl multiplier : 0.4452250071831685       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4518e+04 |  512 |      1 | 3.527e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 935.2764733907311 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.885823277528936, dt = 0.0048829680594325905 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1484.00 ns (0.5%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1074.00 ns (0.4%)
   LB compute        : 277.69 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (64.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.581296279837499e-18,-1.9853259661251066e-17,1.270468105718514e-18)
    sum a = (5.828931087803469e-17,-8.787306819690865e-17,2.2563981932899323e-17)
    sum e = 2.592000540327952
    sum de = 1.0706496453294356e-18
Info: CFL hydro = 0.006912418120776768 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006912418120776768 cfl multiplier : 0.630150004788779         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9757e+04 |  512 |      1 | 2.592e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 678.3155175609393 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.8907062455883685, dt = 0.006912418120776768 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.88 us    (1.3%)
   patch tree reduce : 1759.00 ns (0.6%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 966.00 ns  (0.3%)
   LB compute        : 288.73 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.773348820901301e-18,-2.0482639022378902e-17,1.4783096621839853e-18)
    sum a = (6.578331629425449e-17,-3.184659567306847e-17,7.930765419383868e-17)
    sum e = 2.59200068209785
    sum de = 2.710505431213761e-19
Info: CFL hydro = 0.008269016203785892 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008269016203785892 cfl multiplier : 0.7534333365258528        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9367e+04 |  512 |      1 | 2.644e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 941.3087419849311 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.8976186637091453, dt = 0.008269016203785892 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.37 us    (1.8%)
   patch tree reduce : 1370.00 ns (0.5%)
   gen split merge   : 785.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 285.82 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.32 us    (70.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.2991187906561413e-18,-2.054996797729025e-17,2.1984367451488575e-18)
    sum a = (-3.19900356204883e-17,-9.743670714018603e-17,4.286805285746986e-17)
    sum e = 2.592000808556661
    sum de = -3.496552006265752e-18
Info: CFL hydro = 0.00917452871533255 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00917452871533255 cfl multiplier : 0.8356222243505685         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9440e+04 |  512 |      1 | 2.634e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1130.2982563773446 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.9058876799129312, dt = 0.00917452871533255 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.5%)
   patch tree reduce : 14.18 us   (4.6%)
   gen split merge   : 668.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 952.00 ns  (0.3%)
   LB compute        : 280.09 us  (90.6%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1992.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.87287858033547e-18,-2.1878983000322983e-17,2.499953369317076e-18)
    sum a = (-8.639183118885895e-17,4.039737294680989e-18,-5.916751463774795e-17)
    sum e = 2.5920009218616076
    sum de = -4.0115480381963664e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011207630203017736
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.253433542877883e-18,-2.130229586477794e-17,2.2306375496716766e-18)
    sum a = (6.278571412776657e-17,1.0169599537479535e-16,9.412002427433564e-17)
    sum e = 2.592000407429805
    sum de = -4.7027269231558755e-18
Info: CFL hydro = 0.004884285770802404 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004884285770802404 cfl multiplier : 0.4452074081168562        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4985e+04 |  512 |      1 | 3.417e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 966.6556720944067 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.9150622086282637, dt = 0.004884285770802404 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 1278.00 ns (0.4%)
   gen split merge   : 670.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1057.00 ns (0.4%)
   LB compute        : 277.02 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1839.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.2288624898790806e-18,-2.0523621864498853e-17,3.492323617793058e-18)
    sum a = (-4.7329327956813217e-17,-6.999869434087813e-17,4.682582446791095e-17)
    sum e = 2.5920005507260275
    sum de = 7.995991022080595e-19
Info: CFL hydro = 0.006910495920250517 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006910495920250517 cfl multiplier : 0.6301382720779042        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9634e+04 |  512 |      1 | 2.608e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 674.2795588866101 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.9199464943990661, dt = 0.006910495920250517 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.80 us    (1.1%)
   patch tree reduce : 12.90 us   (2.9%)
   gen split merge   : 871.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1064.00 ns (0.2%)
   LB compute        : 411.13 us  (93.2%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.74 us    (73.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.6533276404071555e-18,-2.1404752970077823e-17,3.6328362193471795e-18)
    sum a = (1.2615689742867532e-16,3.961284425479938e-17,-5.046744272485526e-17)
    sum e = 2.592000715680563
    sum de = 1.395910297075087e-18
Info: CFL hydro = 0.008260605805455661 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008260605805455661 cfl multiplier : 0.7534255147186029        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9941e+04 |  512 |      1 | 2.568e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 968.9034651742977 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.9268569903193166, dt = 0.008260605805455661 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1966.00 ns (0.7%)
   gen split merge   : 1066.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 1014.00 ns (0.3%)
   LB compute        : 275.87 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.38 us    (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.227710203805966e-18,-2.0792937684144253e-17,3.0151662416821877e-18)
    sum a = (4.3652581549480376e-17,2.934371495788568e-17,6.563109430923753e-17)
    sum e = 2.5920008814758875
    sum de = 1.3823577699190182e-18
Info: CFL hydro = 0.009163230073119496 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009163230073119496 cfl multiplier : 0.835617009812402         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9838e+04 |  512 |      1 | 2.581e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1152.2358151691544 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.9351175961247722, dt = 0.009163230073119496 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1070.00 ns (0.4%)
   gen split merge   : 669.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 943.00 ns  (0.3%)
   LB compute        : 277.41 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.68 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1948.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.929120925503458e-18,-2.044458352612466e-17,4.0982842119952065e-18)
    sum a = (8.664943762504151e-19,-7.037339461168913e-17,7.76449217421149e-17)
    sum e = 2.5920010432004177
    sum de = -1.2332799712022613e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010951070606436106
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.1984367451488575e-18,-2.0895394789444133e-17,3.995827106695326e-18)
    sum a = (2.7727820040013285e-17,3.7470027081099033e-19,-4.6134970843603184e-18)
    sum e = 2.592000421342201
    sum de = 1.3823577699190182e-18
Info: CFL hydro = 0.004886856373452965 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004886856373452965 cfl multiplier : 0.44520566993746735       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4829e+04 |  512 |      1 | 3.453e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 955.4347091036705 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.9442808261978917, dt = 0.004886856373452965 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.5%)
   patch tree reduce : 1313.00 ns (0.4%)
   gen split merge   : 692.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1080.00 ns (0.4%)
   LB compute        : 278.75 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.1779453240888814e-18,-2.0558750014887385e-17,3.556725226838697e-18)
    sum a = (-1.0604017663951026e-16,9.697711383926944e-17,-6.99635661904896e-17)
    sum e = 2.5920005951088454
    sum de = 6.776263578034403e-20
Info: CFL hydro = 0.006920580325599721 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006920580325599721 cfl multiplier : 0.6301371132916449        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9561e+04 |  512 |      1 | 2.617e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 672.1187321040596 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.9491676825713447, dt = 0.006920580325599721 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1398.00 ns (0.5%)
   gen split merge   : 691.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 934.00 ns  (0.3%)
   LB compute        : 276.71 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.903927098785175e-18,-1.980642212739969e-17,2.775123880693897e-18)
    sum a = (-8.173149657064727e-18,6.510417205340957e-18,8.4893030105615e-18)
    sum e = 2.5920008041993174
    sum de = 6.098637220230962e-19
Info: CFL hydro = 0.008283407536551745 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008283407536551745 cfl multiplier : 0.7534247421944299        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9171e+04 |  512 |      1 | 2.671e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 932.8764638499117 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 0.9560882628969444, dt = 0.008283407536551745 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.4%)
   patch tree reduce : 1896.00 ns (0.6%)
   gen split merge   : 685.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1029.00 ns (0.3%)
   LB compute        : 297.92 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.675594121259728e-18,-1.989716984923673e-17,3.32839224931325e-18)
    sum a = (6.825399620491446e-17,9.016225266389455e-17,6.86169870922626e-18)
    sum e = 2.5920010146828685
    sum de = 8.131516293641283e-20
Info: CFL hydro = 0.009202448904568306 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009202448904568306 cfl multiplier : 0.8356164947962865        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0024e+04 |  512 |      1 | 2.557e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1166.2627660175303 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.9643716704334961, dt = 0.009202448904568306 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.4%)
   patch tree reduce : 1405.00 ns (0.4%)
   gen split merge   : 738.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 987.00 ns  (0.3%)
   LB compute        : 304.01 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6334589930666609e-18,-1.8885771852633624e-17,3.3430289786418043e-18)
    sum a = (1.0209411441253203e-16,4.1029679653803443e-17,5.999888086360982e-17)
    sum e = 2.592001211026829
    sum de = 4.472333961502706e-18
Info: CFL hydro = 0.009828856217132332 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009828856217132332 cfl multiplier : 0.8904109965308576        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9480e+04 |  512 |      1 | 2.628e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1260.4512111073232 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.9735741193380645, dt = 0.009828856217132332 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1079.00 ns (0.4%)
   gen split merge   : 746.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1266.00 ns (0.4%)
   LB compute        : 273.19 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.58 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.913238648735941e-19,-1.8699885390160986e-17,4.250506197012172e-18)
    sum a = (2.0089203738027362e-16,2.148437677762516e-16,3.786814611883571e-17)
    sum e = 2.5920013852204207
    sum de = -2.4665599424045226e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01033027311041611
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.3418766925686896e-20,-1.7973903615464693e-17,4.1158482871894715e-18)
    sum a = (-3.335417879390956e-17,4.5526082903535325e-17,8.527358506815741e-17)
    sum e = 2.592000446399891
    sum de = 2.846030702774449e-19
Info: CFL hydro = 0.005128412752351348 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005128412752351348 cfl multiplier : 0.4634703321769525        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4918e+04 |  512 |      1 | 3.432e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1030.9772449616191 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.9834029755551968, dt = 0.005128412752351348 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.5%)
   patch tree reduce : 1565.00 ns (0.5%)
   gen split merge   : 936.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 995.00 ns  (0.3%)
   LB compute        : 289.57 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1983.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.18850242147861e-18,-1.8284202277230043e-17,4.879885558140007e-18)
    sum a = (-4.0467629247586955e-17,-4.744642179144165e-17,3.799694933692699e-18)
    sum e = 2.5920006975232073
    sum de = 5.692061405548898e-19
Info: CFL hydro = 0.0071088863078813255 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0071088863078813255 cfl multiplier : 0.6423135547846349       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8601e+04 |  512 |      1 | 2.752e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 670.747422327814 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 0.9885313883075482, dt = 0.0071088863078813255 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1309.00 ns (0.4%)
   gen split merge   : 763.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1149.00 ns (0.4%)
   LB compute        : 297.16 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.68 us    (71.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5339292336324916e-18,-1.8972860392138525e-17,4.6983901144659336e-18)
    sum a = (-5.1433466860539845e-18,1.5269036035547855e-16,4.308614012446532e-17)
    sum e = 2.5920009542396025
    sum de = 1.7618285302889447e-19
Info: CFL hydro = 0.008425826832060616 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008425826832060616 cfl multiplier : 0.7615423698564232        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0371e+04 |  512 |      1 | 2.513e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1018.2369887123252 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 0.9956402746154295, dt = 0.004359725384570523 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.66 us    (1.3%)
   patch tree reduce : 890.00 ns  (0.3%)
   gen split merge   : 916.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 642.00 ns  (0.2%)
   LB compute        : 271.28 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.35 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4519635493925875e-18,-1.7512846641615232e-17,4.979415317574176e-18)
    sum a = (5.590315807924712e-17,-8.257457217997199e-17,-2.076988483545178e-17)
    sum e = 2.5920006376946656
    sum de = 9.486769009248164e-20
Info: CFL hydro = 0.009304315738503063 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009304315738503063 cfl multiplier : 0.8410282465709488        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0061e+04 |  512 |      1 | 2.552e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 614.9535589702766 (tsim/hr)                             [sph::Model][rank=0]
Info: iteration since start : 134                                                     [SPH][rank=0]
Info: time since start : 1734.116839303 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14945454052672802 max=0.150534825261683 delta=0.0010802847349549727
Number of particle pairs: 130816
Distance min=0.145957 max=1.918931 mean=0.806421
---------------- t = 1, dt = 0.009304315738503063 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.73 us    (1.7%)
   patch tree reduce : 1077.00 ns (0.2%)
   gen split merge   : 421.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 846.00 ns  (0.1%)
   LB compute        : 543.68 us  (95.8%)
   LB move op cnt    : 0
   LB apply          : 4.39 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.46 us    (77.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.484600604903192e-19,-1.8936268568817138e-17,4.6603346182116925e-18)
    sum a = (-7.292018551485758e-18,6.50573345195582e-17,-3.8840024946251716e-17)
    sum e = 2.5920013482533313
    sum de = 2.1412992906588713e-18
Info: CFL hydro = 0.009888334468958154 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009888334468958154 cfl multiplier : 0.8940188310472991        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.3778e+04 |  512 |      1 | 3.716e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 901.3411148527259 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.009304315738503, dt = 0.009888334468958154 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (0.7%)
   patch tree reduce : 1248.00 ns (0.2%)
   gen split merge   : 1005.00 ns (0.2%)
   split / merge op  : 0/0
   apply split merge : 984.00 ns  (0.2%)
   LB compute        : 605.74 us  (97.2%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (0.5%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1925.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.334869714764153e-18,-1.7605149515943426e-17,4.247578851146461e-18)
    sum a = (4.6872662001762323e-17,3.559652572704408e-18,1.0717013214367466e-16)
    sum e = 2.592001478679999
    sum de = 2.7376104855258987e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010281992654337813
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.547849927875717e-19,-1.795222296014677e-17,4.912086362662826e-18)
    sum a = (1.4630289167649745e-16,-6.96942503708442e-17,1.426202905774332e-16)
    sum e = 2.5920004443012505
    sum de = 1.8973538018496328e-19
Info: CFL hydro = 0.005136129032393748 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005136129032393748 cfl multiplier : 0.464672943682433         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4257e+04 |  512 |      1 | 3.591e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 991.2307384367246 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.0191926502074613, dt = 0.005136129032393748 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.89 us    (1.4%)
   patch tree reduce : 1178.00 ns (0.3%)
   gen split merge   : 1075.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 962.00 ns  (0.3%)
   LB compute        : 334.75 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.44956571588051e-19,-1.8595232775461823e-17,5.810781543436061e-18)
    sum a = (8.41670483309187e-17,1.195293863887059e-16,-1.0380368439810716e-16)
    sum e = 2.5920007207894775
    sum de = 1.8431436932253575e-18
Info: CFL hydro = 0.007104976628083191 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007104976628083191 cfl multiplier : 0.6431152957882887        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9627e+04 |  512 |      1 | 2.609e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 708.803101266008 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 1.024328779239855, dt = 0.007104976628083191 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1162.00 ns (0.4%)
   gen split merge   : 956.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 963.00 ns  (0.3%)
   LB compute        : 280.02 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1983.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.913238648735941e-19,-1.7341596908471147e-17,4.505185287329016e-18)
    sum a = (-3.3500546087195104e-17,-1.7704587795819292e-17,1.7411853209248207e-17)
    sum e = 2.5920009657058034
    sum de = 2.0328790734103208e-19
Info: CFL hydro = 0.00841537330772173 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00841537330772173 cfl multiplier : 0.7620768638588592         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9766e+04 |  512 |      1 | 2.590e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 987.4403742255938 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.0314337558679383, dt = 0.00841537330772173 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.89 us    (1.3%)
   patch tree reduce : 988.00 ns  (0.3%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 972.00 ns  (0.3%)
   LB compute        : 285.85 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.48 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1890.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1123914289701276e-19,-1.7768257568398505e-17,5.0760177311426344e-18)
    sum a = (7.187219569493308e-17,-4.323104374481801e-17,1.2135605020890948e-16)
    sum e = 2.592001155750665
    sum de = -1.9786689647860456e-18
Info: CFL hydro = 0.009289086840441286 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009289086840441286 cfl multiplier : 0.8413845759059061        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9984e+04 |  512 |      1 | 2.562e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1182.4767447695456 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.03984912917566, dt = 0.009289086840441286 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.4%)
   patch tree reduce : 938.00 ns  (0.3%)
   gen split merge   : 637.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 575.00 ns  (0.2%)
   LB compute        : 274.99 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.53 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1859.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1592289628215014e-18,-1.829152064189432e-17,6.571891468520885e-18)
    sum a = (1.9952789420685236e-17,-4.013976651062734e-17,7.020946324320931e-17)
    sum e = 2.5920012724370083
    sum de = 2.5004412602946946e-18
Info: CFL hydro = 0.009874402645905016 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009874402645905016 cfl multiplier : 0.8942563839372708        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0478e+04 |  512 |      1 | 2.500e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1337.4993560857215 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.0491382160161014, dt = 0.009874402645905016 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.88 us    (1.3%)
   patch tree reduce : 948.00 ns  (0.3%)
   gen split merge   : 520.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 495.00 ns  (0.2%)
   LB compute        : 282.84 us  (95.7%)
   LB move op cnt    : 0
   LB apply          : 2.46 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1592289628215014e-18,-1.8812588205990855e-17,7.10174107021455e-18)
    sum a = (4.796163466380676e-17,7.2551339935778e-17,1.2739809207573672e-17)
    sum e = 2.5920013204214496
    sum de = 2.5614276324970042e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010884714461703065
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4578182411240092e-18,-1.8134907638078788e-17,6.735822837000694e-18)
    sum a = (3.140456644734613e-17,-5.287957571820101e-17,6.41674213763821e-17)
    sum e = 2.592000429960567
    sum de = -1.1384122811097797e-18
Info: CFL hydro = 0.005133995305369493 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005133995305369493 cfl multiplier : 0.46475212797909027       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4992e+04 |  512 |      1 | 3.415e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1040.894840868386 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.0590126186620064, dt = 0.005133995305369493 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.95 us    (1.3%)
   patch tree reduce : 1238.00 ns (0.4%)
   gen split merge   : 992.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 747.00 ns  (0.2%)
   LB compute        : 289.57 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.55 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1970.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3231603313013097e-18,-1.9175579093339e-17,7.16321533339448e-18)
    sum a = (3.6111738599409194e-17,-4.0046091442924593e-17,1.2047784644919623e-16)
    sum e = 2.5920006703315677
    sum de = -8.944667923005412e-19
Info: CFL hydro = 0.0070991652392932095 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070991652392932095 cfl multiplier : 0.6431680853193935       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0351e+04 |  512 |      1 | 2.516e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 734.6560007149322 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.0641466139673759, dt = 0.0070991652392932095 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.61 us    (1.2%)
   patch tree reduce : 898.00 ns  (0.3%)
   gen split merge   : 653.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 510.00 ns  (0.2%)
   LB compute        : 295.05 us  (95.7%)
   LB move op cnt    : 0
   LB apply          : 2.54 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.31 us    (70.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4373268200640332e-18,-1.9592725879202797e-17,8.301952875156005e-18)
    sum a = (-1.737204130547454e-16,1.8088655573400558e-16,8.693046282814976e-17)
    sum e = 2.592000854965335
    sum de = -1.9413995151068564e-18
Info: CFL hydro = 0.008405097957831726 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008405097957831726 cfl multiplier : 0.7621120568795957        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0106e+04 |  512 |      1 | 2.546e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1003.6183542012669 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.071245779206669, dt = 0.008405097957831726 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.4%)
   patch tree reduce : 953.00 ns  (0.3%)
   gen split merge   : 713.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 571.00 ns  (0.2%)
   LB compute        : 270.34 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 2.28 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.220080452281948e-19,-1.6832238727837456e-17,8.843511860312513e-18)
    sum a = (5.7891191840298e-17,1.6318196793818629e-16,-6.030332483364376e-17)
    sum e = 2.592000978833192
    sum de = 1.1214716221646936e-18
Info: CFL hydro = 0.009274429039479053 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009274429039479053 cfl multiplier : 0.8414080379197305        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8481e+04 |  512 |      1 | 2.770e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1092.1855768426947 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.0796508771645006, dt = 0.009274429039479053 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1222.00 ns (0.4%)
   gen split merge   : 706.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 750.00 ns  (0.2%)
   LB compute        : 301.55 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.01 us    (71.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.386316392907986e-19,-1.5678864456747376e-17,7.684282897491013e-18)
    sum a = (7.365202198128528e-17,7.198928952956152e-17,4.5432407835832574e-18)
    sum e = 2.5920010376078197
    sum de = -1.4484263398048536e-18
Info: CFL hydro = 0.009856201312261737 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009856201312261737 cfl multiplier : 0.8942720252798203        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9384e+04 |  512 |      1 | 2.641e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1264.021873131661 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.0889253062039796, dt = 0.009856201312261737 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.97 us    (1.4%)
   patch tree reduce : 1180.00 ns (0.4%)
   gen split merge   : 869.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 938.00 ns  (0.3%)
   LB compute        : 271.87 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1844.00 ns (64.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.443181511795455e-18,-1.545345882508764e-17,8.176077002930438e-18)
    sum a = (-2.5854318685958333e-17,4.489377619654178e-17,4.065497938299245e-17)
    sum e = 2.5920010485076226
    sum de = 9.745114058160725e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010927020423124436
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1592289628215014e-18,-1.5333437644593494e-17,8.099966010421955e-18)
    sum a = (-6.152110071377948e-17,-1.847740710436696e-17,-1.0180137982596094e-16)
    sum e = 2.592000419599817
    sum de = -3.65282958503417e-21
Info: CFL hydro = 0.0051264075864635725 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0051264075864635725 cfl multiplier : 0.46475734175994016      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4301e+04 |  512 |      1 | 3.580e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 991.0484061670971 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.0987815075162415, dt = 0.0051264075864635725 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 1059.00 ns (0.4%)
   gen split merge   : 841.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 854.00 ns  (0.3%)
   LB compute        : 274.66 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.32 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.58652819784944e-19,-1.5936470892929933e-17,7.025630077706068e-18)
    sum a = (4.871103520542874e-18,-9.6860020004641e-17,-2.789175140849309e-17)
    sum e = 2.5920005893818177
    sum de = 3.522810027630635e-18
Info: CFL hydro = 0.007097456334928237 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007097456334928237 cfl multiplier : 0.6431715611732934        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.1282e+04 |  512 |      1 | 4.538e-02 | 0.0% |   1.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 406.64610251500625 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.1039079151027051, dt = 0.007097456334928237 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.4%)
   patch tree reduce : 1470.00 ns (0.5%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 834.00 ns  (0.3%)
   LB compute        : 296.76 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.703622032477874e-19,-1.6486811915683574e-17,7.078322303288864e-18)
    sum a = (6.618143533199116e-17,-6.875749969381673e-17,-3.3441999169880885e-17)
    sum e = 2.5920007190024434
    sum de = -2.1023357750851734e-18
Info: CFL hydro = 0.008408021770251552 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008408021770251552 cfl multiplier : 0.7621143741155288        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7851e+04 |  512 |      1 | 2.868e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 890.8181574388673 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.1110053714376333, dt = 0.008408021770251552 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1391.00 ns (0.5%)
   gen split merge   : 654.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 820.00 ns  (0.3%)
   LB compute        : 273.74 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8354458578007103e-18,-1.701373417151153e-17,6.551400047460909e-18)
    sum a = (-4.2013267864682293e-17,9.662583233538413e-17,-1.0625094554184144e-16)
    sum e = 2.592000812739162
    sum de = -3.0357660829594124e-18
Info: CFL hydro = 0.009270504247079198 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009270504247079198 cfl multiplier : 0.8414095827436858        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9983e+04 |  512 |      1 | 2.562e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1181.362043936884 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.119413393207885, dt = 0.009270504247079198 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.76 us    (1.3%)
   patch tree reduce : 1318.00 ns (0.4%)
   gen split merge   : 676.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1137.00 ns (0.4%)
   LB compute        : 280.56 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1956.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.308959852960541e-19,-1.5371493140847735e-17,5.269222558279552e-18)
    sum a = (-1.1381520725883831e-16,1.5128523433993735e-17,-2.8079101543898586e-17)
    sum e = 2.592000875230392
    sum de = -1.6974540262976179e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010428504987451261
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.2786273695961654e-19,-1.6217496096038177e-17,5.740525242659001e-18)
    sum a = (-4.6790696317522416e-17,-8.642695933924749e-17,6.910878119770202e-17)
    sum e = 2.592000427720591
    sum de = 1.5619287547369298e-18
Info: CFL hydro = 0.004922690365196898 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004922690365196898 cfl multiplier : 0.4471365275812286        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4685e+04 |  512 |      1 | 3.487e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 957.2186872323003 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.128683897454964, dt = 0.004922690365196898 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.4%)
   patch tree reduce : 1376.00 ns (0.4%)
   gen split merge   : 724.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 963.00 ns  (0.3%)
   LB compute        : 285.98 us  (91.2%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (68.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.693158196453993e-19,-1.6925913795540204e-17,6.320139724069751e-18)
    sum a = (1.635566682089973e-16,4.67321494002082e-17,-6.006913716438688e-17)
    sum e = 2.592000552332388
    sum de = 2.846030702774449e-19
Info: CFL hydro = 0.006948129224682266 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006948129224682266 cfl multiplier : 0.6314243517208191        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9871e+04 |  512 |      1 | 2.577e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 687.778767529514 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 1.1336065878201609, dt = 0.006948129224682266 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.3%)
   patch tree reduce : 1308.00 ns (0.4%)
   gen split merge   : 670.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 938.00 ns  (0.3%)
   LB compute        : 287.03 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.70 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9920588616162416e-18,-1.64399743818322e-17,5.722961167464735e-18)
    sum a = (-3.419139971150287e-18,7.616953942579662e-17,1.4988010832439613e-18)
    sum e = 2.5920006761177383
    sum de = 3.130633773051894e-18
Info: CFL hydro = 0.008296531785145677 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008296531785145677 cfl multiplier : 0.7542829011472127        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0081e+04 |  512 |      1 | 2.550e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 981.054979594726 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 1.1405547170448431, dt = 0.008296531785145677 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.4%)
   patch tree reduce : 1392.00 ns (0.5%)
   gen split merge   : 678.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 920.00 ns  (0.3%)
   LB compute        : 273.61 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5866214592152872e-18,-1.5956962313989908e-17,5.995204332975845e-18)
    sum a = (9.981078463727755e-17,9.508897575588592e-17,-3.463635628309092e-17)
    sum e = 2.5920007900909083
    sum de = 1.3755815063409838e-18
Info: CFL hydro = 0.009196471731798496 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009196471731798496 cfl multiplier : 0.8361886007648085        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9680e+04 |  512 |      1 | 2.602e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1148.0269887792042 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.148851248829989, dt = 0.009196471731798496 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.90 us    (1.7%)
   patch tree reduce : 1435.00 ns (0.5%)
   gen split merge   : 736.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 963.00 ns  (0.3%)
   LB compute        : 278.49 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1989.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5841145629562635e-18,-1.4660148095479998e-17,5.58683958470918e-18)
    sum a = (9.465865591362643e-17,5.049671618351237e-17,-8.358157915777653e-17)
    sum e = 2.592000897703226
    sum de = 8.673617379884035e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011328662637587797
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.6792533035918663e-18,-1.4859207614348335e-17,5.472673095946457e-18)
    sum a = (4.590078317434632e-17,-1.1108399356613007e-16,-2.4566286505045554e-17)
    sum e = 2.5920004405069506
    sum de = 2.0599841277224584e-18
Info: CFL hydro = 0.00490160733391541 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00490160733391541 cfl multiplier : 0.44539620025493615        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4554e+04 |  512 |      1 | 3.518e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 941.131532954475 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 1.1580477205617874, dt = 0.00490160733391541 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.3%)
   patch tree reduce : 1097.00 ns (0.4%)
   gen split merge   : 644.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1455.00 ns (0.5%)
   LB compute        : 283.98 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5969217011187484e-18,-1.5880851321481426e-17,5.575862037712764e-18)
    sum a = (-7.353492814665685e-17,-1.173104582224971e-16,-8.465884243635813e-17)
    sum e = 2.592000567903059
    sum de = 1.849919956803392e-18
Info: CFL hydro = 0.006938561913024321 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006938561913024321 cfl multiplier : 0.6302641335032907        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0010e+04 |  512 |      1 | 2.559e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 689.6276072182629 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.1629493278957028, dt = 0.006938561913024321 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.6%)
   patch tree reduce : 904.00 ns  (0.3%)
   gen split merge   : 691.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 941.00 ns  (0.3%)
   LB compute        : 275.11 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5811326857170793e-18,-1.700787947978011e-17,4.615692593759601e-18)
    sum a = (-1.0126274818667014e-16,5.175547490576804e-17,2.2060478443997057e-17)
    sum e = 2.59200072108476
    sum de = -5.21772295508649e-19
Info: CFL hydro = 0.008299066695194047 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008299066695194047 cfl multiplier : 0.7535094223355271        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9980e+04 |  512 |      1 | 2.563e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 974.7576175897783 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.169887889808727, dt = 0.008299066695194047 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.4%)
   patch tree reduce : 1429.00 ns (0.5%)
   gen split merge   : 795.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 961.00 ns  (0.3%)
   LB compute        : 273.27 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.973815699521477e-19,-1.562324488529887e-17,5.458951162200937e-18)
    sum a = (-1.0533761363173966e-16,3.995241637522184e-17,-7.39798847182449e-17)
    sum e = 2.5920008810126074
    sum de = 4.472333961502706e-19
Info: CFL hydro = 0.009209689092859496 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009209689092859496 cfl multiplier : 0.8356729482236848        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9716e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1150.4672355175223 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.1781869565039211, dt = 0.009209689092859496 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.3%)
   patch tree reduce : 1562.00 ns (0.5%)
   gen split merge   : 773.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 941.00 ns  (0.3%)
   LB compute        : 304.78 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3648750098876894e-19,-1.5222198501696483e-17,4.153171946977285e-18)
    sum a = (2.2482016248659418e-17,1.3676559884601148e-17,3.519840668930741e-17)
    sum e = 2.592001043200036
    sum de = -9.486769009248164e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011651858369080954
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.812867990088398e-19,-1.5634954268761713e-17,4.8738479072919785e-18)
    sum a = (-1.1892049844863805e-16,-3.5502850659341336e-17,-1.2177758801357186e-16)
    sum e = 2.5920004552336438
    sum de = 1.6059744679941534e-18
Info: CFL hydro = 0.004906003155248845 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004906003155248845 cfl multiplier : 0.44522431607456153       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4750e+04 |  512 |      1 | 3.471e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 955.1229106677914 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.1873966455967806, dt = 0.004906003155248845 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.4%)
   patch tree reduce : 1236.00 ns (0.4%)
   gen split merge   : 728.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1283.00 ns (0.4%)
   LB compute        : 291.20 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.793015144129002e-19,-1.5406621291236266e-17,3.513180957086248e-18)
    sum a = (-4.730590918988753e-18,-3.124063507886632e-17,4.051446678143833e-18)
    sum e = 2.592000618928445
    sum de = 1.9244588561617704e-18
Info: CFL hydro = 0.006943424032201546 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006943424032201546 cfl multiplier : 0.6301495440497077        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9608e+04 |  512 |      1 | 2.611e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 676.3904830850918 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.1923026487520294, dt = 0.006943424032201546 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1238.00 ns (0.4%)
   gen split merge   : 962.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 912.00 ns  (0.3%)
   LB compute        : 276.93 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1877.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.79405836745517e-19,-1.595988965985562e-17,3.934352843515398e-18)
    sum a = (-1.0575915143640202e-16,-1.0327676214227921e-17,-1.779826286352204e-17)
    sum e = 2.5920008221014115
    sum de = -1.0299920638612292e-18
Info: CFL hydro = 0.008303705122744235 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008303705122744235 cfl multiplier : 0.7534330293664718        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0167e+04 |  512 |      1 | 2.539e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 984.5577977201917 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.199246072784231, dt = 0.008303705122744235 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.5%)
   patch tree reduce : 1080.00 ns (0.4%)
   gen split merge   : 796.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1070.00 ns (0.4%)
   LB compute        : 271.29 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1972.00 ns (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6561459235259201e-18,-1.6319953201338056e-17,3.643081929877168e-18)
    sum a = (6.276229536084088e-17,-6.845305572378279e-17,-5.388658269600555e-17)
    sum e = 2.5920010312192905
    sum de = 5.963111948670274e-19
Info: CFL hydro = 0.009215799816497438 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009215799816497438 cfl multiplier : 0.8356220195776478        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9726e+04 |  512 |      1 | 2.596e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1151.698839301949 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.207549777906975, dt = 0.009215799816497438 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 1183.00 ns (0.4%)
   gen split merge   : 741.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 778.00 ns  (0.3%)
   LB compute        : 284.36 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1920.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.7909128960955664e-19,-1.7382579750591098e-17,3.012238895816477e-18)
    sum a = (-2.3746629662646512e-17,-1.2271433869059933e-17,-1.5315873569399228e-16)
    sum e = 2.5920012310563294
    sum de = 2.236166980751353e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011668811812013557
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.567189062862578e-19,-1.7130828006139963e-17,2.4472611437342805e-18)
    sum a = (-1.4702301875946233e-16,6.248127015773264e-17,3.545601312548996e-17)
    sum e = 2.592000466297279
    sum de = -1.4094628242311558e-18
Info: CFL hydro = 0.0049174504330755115 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0049174504330755115 cfl multiplier : 0.44520733985921596      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5104e+04 |  512 |      1 | 3.390e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 978.6932001266217 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.2167655777234725, dt = 0.0049174504330755115 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.75 us    (1.6%)
   patch tree reduce : 1282.00 ns (0.4%)
   gen split merge   : 686.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1247.00 ns (0.4%)
   LB compute        : 276.32 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.0813429105204228e-18,-1.6328735238935187e-17,3.625517854682903e-18)
    sum a = (-1.7941117341768732e-16,-6.838279942300574e-17,-5.222385024428178e-17)
    sum e = 2.592000680920581
    sum de = -1.4230153513872246e-18
Info: CFL hydro = 0.006965868622475744 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006965868622475744 cfl multiplier : 0.6301382265728107        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0649e+04 |  512 |      1 | 2.480e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 713.9473831675958 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.221683028156548, dt = 0.006965868622475744 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1445.00 ns (0.5%)
   gen split merge   : 1050.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 999.00 ns  (0.3%)
   LB compute        : 284.76 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.66 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.44694975687454e-18,-1.718352023172276e-17,3.076640504862116e-18)
    sum a = (5.618162185472286e-17,-1.5622659416125727e-16,8.875712664835334e-18)
    sum e = 2.592000930953127
    sum de = -3.1848438816761693e-19
Info: CFL hydro = 0.008340812618859439 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008340812618859439 cfl multiplier : 0.7534254843818738        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0226e+04 |  512 |      1 | 2.531e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 990.6395579926979 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.228648896779024, dt = 0.008340812618859439 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.6%)
   patch tree reduce : 986.00 ns  (0.3%)
   gen split merge   : 702.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 963.00 ns  (0.3%)
   LB compute        : 270.05 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.44 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.1720906323574595e-18,-1.850375321715836e-17,3.511351365920179e-18)
    sum a = (4.2809505940155647e-17,-1.9723285504813504e-16,-1.4988010832439614e-16)
    sum e = 2.592001170775738
    sum de = -2.053207864144424e-18
Info: CFL hydro = 0.009270267670525861 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009270267670525861 cfl multiplier : 0.8356169895879159        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9817e+04 |  512 |      1 | 2.584e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1162.2030003271368 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.2369897093978834, dt = 0.009270267670525861 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.3%)
   patch tree reduce : 914.00 ns  (0.3%)
   gen split merge   : 671.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 840.00 ns  (0.3%)
   LB compute        : 293.19 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (68.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.9232662337720364e-18,-2.0552895323155963e-17,1.324624004234165e-18)
    sum a = (3.632250750174038e-17,5.091239929644331e-17,-2.3582698294166704e-17)
    sum e = 2.592001376015492
    sum de = 4.472333961502706e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010150283061544993
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.952539692429145e-18,-1.9761048266481173e-17,1.7607985382250836e-18)
    sum a = (9.39209647554673e-17,-4.1310704856911684e-17,8.039662685588312e-17)
    sum e = 2.5920004700103907
    sum de = -7.250602028496811e-19
Info: CFL hydro = 0.004953906040455429 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004953906040455429 cfl multiplier : 0.445205663195972         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4883e+04 |  512 |      1 | 3.440e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 970.1046126948557 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.2462599770684093, dt = 0.004953906040455429 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.5%)
   patch tree reduce : 1112.00 ns (0.4%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1222.00 ns (0.4%)
   LB compute        : 292.52 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.38 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0245710529988016e-18,-2.0405064356937562e-17,2.8131793769481383e-18)
    sum a = (-6.645075115163656e-17,1.8055869299704596e-16,-5.634555322320267e-17)
    sum e = 2.5920007262539095
    sum de = -4.438452643612534e-18
Info: CFL hydro = 0.007022389194598699 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007022389194598699 cfl multiplier : 0.6301371087973147        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9501e+04 |  512 |      1 | 2.626e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 679.2507420881805 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.2512138831088648, dt = 0.007022389194598699 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.5%)
   patch tree reduce : 1283.00 ns (0.4%)
   gen split merge   : 688.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 921.00 ns  (0.3%)
   LB compute        : 302.51 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1987.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.0593878165275912e-18,-1.8177354153131597e-17,2.1179347338418088e-18)
    sum a = (-5.143932155227127e-17,-7.793765632868598e-17,-3.798523995346414e-17)
    sum e = 2.5920009967927333
    sum de = 1.5517643593698782e-18
Info: CFL hydro = 0.00839719910970461 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00839719910970461 cfl multiplier : 0.7534247391982097         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9707e+04 |  512 |      1 | 2.598e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 973.0578729174031 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.2582362723034635, dt = 0.00839719910970461 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.5%)
   patch tree reduce : 1387.00 ns (0.5%)
   gen split merge   : 723.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1185.00 ns (0.4%)
   LB compute        : 280.36 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.7502414408353547e-18,-1.9930834326692403e-17,1.946685000697723e-18)
    sum a = (-4.6246209986500197e-17,5.5502477613877945e-17,-1.962492668372562e-17)
    sum e = 2.59200122804839
    sum de = -2.846030702774449e-19
Info: CFL hydro = 0.009293990959006288 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009293990959006288 cfl multiplier : 0.8356164927988065        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9982e+04 |  512 |      1 | 2.562e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1179.8137869733055 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.2666334714131682, dt = 0.009293990959006288 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.4%)
   patch tree reduce : 1500.00 ns (0.5%)
   gen split merge   : 741.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1270.00 ns (0.4%)
   LB compute        : 280.20 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1924.00 ns (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.608265166348378e-18,-1.8717449465355252e-17,1.7271340607694085e-18)
    sum a = (-4.142779869154012e-17,-2.6135343889066574e-17,-2.9765252762548045e-17)
    sum e = 2.5920013888213953
    sum de = -2.0396553369883552e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010070115982217692
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.9156364822480185e-18,-1.9209243570794677e-17,1.6890785645151674e-18)
    sum a = (2.5450344956490234e-17,-1.0735162758734873e-16,-1.1564187107904189e-16)
    sum e = 2.592000465684042
    sum de = -1.2265037076242269e-18
Info: CFL hydro = 0.004942028342032615 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004942028342032615 cfl multiplier : 0.4452054975996022        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4762e+04 |  512 |      1 | 3.468e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 964.6793768680983 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.2759274623721744, dt = 0.004942028342032615 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.4%)
   patch tree reduce : 1324.00 ns (0.4%)
   gen split merge   : 969.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1152.00 ns (0.4%)
   LB compute        : 279.68 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.461897873062835e-18,-2.0119648135030754e-17,7.376911581591372e-19)
    sum a = (-5.3573539647491093e-17,-7.68603930501044e-17,-7.154433295797347e-18)
    sum e = 2.5920007252922357
    sum de = -1.2671612890924333e-18
Info: CFL hydro = 0.006987766021190458 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006987766021190458 cfl multiplier : 0.6301369983997348        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9237e+04 |  512 |      1 | 2.662e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 668.4461549412953 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.280869490714207, dt = 0.006987766021190458 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.81 us    (1.2%)
   patch tree reduce : 1210.00 ns (0.4%)
   gen split merge   : 879.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1022.00 ns (0.3%)
   LB compute        : 308.47 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.45 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.0649311213992723e-18,-2.0828065834532782e-17,8.69421722116126e-19)
    sum a = (3.7133382306542285e-17,1.44727979600745e-17,4.784454082917833e-17)
    sum e = 2.59200096756239
    sum de = 2.507217523872729e-19
Info: CFL hydro = 0.008344706158170357 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008344706158170357 cfl multiplier : 0.7534246655998231        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9710e+04 |  512 |      1 | 2.598e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 968.4237235987791 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.2878572567353976, dt = 0.008344706158170357 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.53 us    (1.2%)
   patch tree reduce : 1128.00 ns (0.4%)
   gen split merge   : 532.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 763.00 ns  (0.3%)
   LB compute        : 287.79 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.4223787038757384e-18,-2.0146039987601303e-17,1.4724549704525635e-18)
    sum a = (1.704652044520749e-16,1.0173112352518387e-16,-4.6872662001762323e-17)
    sum e = 2.5920011490289445
    sum de = -2.371692252312041e-19
Info: CFL hydro = 0.00924395636514672 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00924395636514672 cfl multiplier : 0.8356164437332154         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0052e+04 |  512 |      1 | 2.553e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1176.5449940094934 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.296201962893568, dt = 0.00924395636514672 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.84 us    (1.3%)
   patch tree reduce : 1430.00 ns (0.5%)
   gen split merge   : 587.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 821.00 ns  (0.3%)
   LB compute        : 288.59 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.70 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.14742631799281e-20,-1.8806733514259433e-17,5.29849601693666e-19)
    sum a = (-6.682545142244756e-17,-1.4552421767621836e-16,-4.6673602482893983e-17)
    sum e = 2.5920012494113345
    sum de = -6.437450399132683e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010125034071926237
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3158419666370324e-18,-2.0087447330507935e-17,5.415589851565095e-19)
    sum a = (-8.657918132426446e-17,1.4641413081939447e-16,4.013976651062734e-17)
    sum e = 2.592000457336149
    sum de = -1.8804131429045468e-18
Info: CFL hydro = 0.004919156022675692 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004919156022675692 cfl multiplier : 0.4452054812444051        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4984e+04 |  512 |      1 | 3.417e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 973.919497046105 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 1.3054459192587147, dt = 0.004919156022675692 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.96 us    (1.4%)
   patch tree reduce : 969.00 ns  (0.3%)
   gen split merge   : 530.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1258.00 ns (0.4%)
   LB compute        : 273.10 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1825.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.8661829893906744e-18,-1.8033182369245338e-17,1.2148485342700077e-18)
    sum a = (1.8688176006698142e-17,-2.201364091014568e-18,1.0260932728489713e-16)
    sum e = 2.5920006811813496
    sum de = -1.870248747537495e-18
Info: CFL hydro = 0.006958265975329901 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006958265975329901 cfl multiplier : 0.63013698749627          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0024e+04 |  512 |      1 | 2.557e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 692.5817595194214 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.3103650752813905, dt = 0.006958265975329901 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.3%)
   patch tree reduce : 1007.00 ns (0.3%)
   gen split merge   : 544.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 314.86 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4768459892511298e-18,-1.8492775670161944e-17,2.054996797729025e-18)
    sum a = (1.8293569784000317e-16,8.194226547297845e-17,-5.2194576785624666e-17)
    sum e = 2.592000867875122
    sum de = -6.810144895924575e-19
Info: CFL hydro = 0.008314298237742102 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008314298237742102 cfl multiplier : 0.7534246583308466        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9957e+04 |  512 |      1 | 2.566e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 976.3884958099526 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.3173233412567205, dt = 0.008314298237742102 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1019.00 ns (0.3%)
   gen split merge   : 537.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 981.00 ns  (0.3%)
   LB compute        : 278.89 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.283859287608106e-19,-1.7591884979989424e-17,1.1767930380157664e-18)
    sum a = (1.179837477716106e-16,-2.693158196453993e-17,-8.280875984922886e-17)
    sum e = 2.592000989857841
    sum de = -1.1553529400548657e-18
Info: CFL hydro = 0.009217105054514344 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009217105054514344 cfl multiplier : 0.835616438887231         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9494e+04 |  512 |      1 | 2.626e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1139.6318220814885 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.3256376394944627, dt = 0.009217105054514344 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.4%)
   patch tree reduce : 1248.00 ns (0.4%)
   gen split merge   : 744.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1346.00 ns (0.4%)
   LB compute        : 297.21 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.39 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5002647561768168e-18,-1.8276883912565767e-17,3.1908069936248396e-19)
    sum a = (4.0865748285323635e-17,8.64855062565617e-17,3.588340562188375e-17)
    sum e = 2.59200103835422
    sum de = -2.5783682914420902e-18
Info: CFL hydro = 0.00982040771066941 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00982040771066941 cfl multiplier : 0.890410959258154          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9760e+04 |  512 |      1 | 2.591e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1280.594771170823 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.3348547445489771, dt = 0.00982040771066941 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1129.00 ns (0.4%)
   gen split merge   : 802.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 275.11 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1908.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5266108689682146e-18,-1.676637344585896e-17,1.080190624447308e-18)
    sum a = (4.5081126331947276e-17,-3.079567850727827e-17,-4.930382274323519e-18)
    sum e = 2.5920010293848756
    sum de = -2.9879087214395444e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011195151187220899
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6612687787909141e-18,-1.736647934832969e-17,7.640372709505349e-19)
    sum a = (-1.7348622538548852e-16,-2.1217402834672327e-17,1.769580575822216e-17)
    sum e = 2.5920004380592876
    sum de = -3.587687457434394e-18
Info: CFL hydro = 0.005114012205972845 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005114012205972845 cfl multiplier : 0.46347031975271796       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4694e+04 |  512 |      1 | 3.484e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1014.6399986617214 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.3446751522596465, dt = 0.005114012205972845 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.3%)
   patch tree reduce : 1037.00 ns (0.3%)
   gen split merge   : 931.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 907.00 ns  (0.3%)
   LB compute        : 301.81 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.2885616932664126e-19,-1.7220112055044144e-17,9.191866018332106e-19)
    sum a = (5.643922829090541e-17,-8.519747407564893e-17,-3.925278071331695e-17)
    sum e = 2.5920005990083537
    sum de = -3.4330245352216793e-18
Info: CFL hydro = 0.007088145809315882 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007088145809315882 cfl multiplier : 0.6423135465018119        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0088e+04 |  512 |      1 | 2.549e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 722.334970606158 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 1.3497891644656193, dt = 0.007088145809315882 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.4%)
   patch tree reduce : 1328.00 ns (0.5%)
   gen split merge   : 734.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 962.00 ns  (0.3%)
   LB compute        : 274.52 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.78 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1933.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.962380754733545e-19,-1.8290056968961465e-17,5.679050979479072e-19)
    sum a = (-5.80785419757035e-17,-5.1333937101105673e-17,1.5826695422965774e-16)
    sum e = 2.5920007086200307
    sum de = 9.0801931945661e-19
Info: CFL hydro = 0.008403456666670393 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008403456666670393 cfl multiplier : 0.7615423643345413        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0220e+04 |  512 |      1 | 2.532e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1007.7571436732962 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.3568773102749352, dt = 0.008403456666670393 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.3%)
   patch tree reduce : 1223.00 ns (0.4%)
   gen split merge   : 702.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 829.00 ns  (0.3%)
   LB compute        : 303.71 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.078415564654712e-19,-1.8513998927688348e-17,2.587773745288402e-18)
    sum a = (5.302008831975513e-17,-4.228258368432769e-17,-8.273850354845181e-17)
    sum e = 2.5920007741968694
    sum de = 3.2000904747267467e-18
Info: CFL hydro = 0.009278141931089157 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009278141931089157 cfl multiplier : 0.8410282428896941        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9438e+04 |  512 |      1 | 2.634e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1148.5443291290292 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.3652807669416056, dt = 0.009278141931089157 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 2.27 us    (0.7%)
   gen split merge   : 801.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 932.00 ns  (0.3%)
   LB compute        : 295.01 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.374038767099134e-19,-1.8995547322597784e-17,7.464731957562698e-19)
    sum a = (-3.8734640495086127e-17,5.457743632031331e-17,-6.736408306173835e-17)
    sum e = 2.5920008020919503
    sum de = -7.386127300057499e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010069479407666658
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.842927816585407e-19,-1.8524244638218334e-17,9.54314752221741e-19)
    sum a = (8.622789982037915e-17,1.633458993066661e-17,1.1674255312454918e-17)
    sum e = 2.592000443091255
    sum de = 2.40896170199123e-18
Info: CFL hydro = 0.004931084019060342 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004931084019060342 cfl multiplier : 0.44700941429656477       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4366e+04 |  512 |      1 | 3.564e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 937.1682779507596 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.3745589088726948, dt = 0.004931084019060342 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.2%)
   patch tree reduce : 1161.00 ns (0.3%)
   gen split merge   : 676.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 321.63 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3216509185893024e-18,-1.857986420966684e-17,1.249976684658538e-18)
    sum a = (-1.1241008124329709e-17,3.90507938485829e-17,9.777335191474278e-18)
    sum e = 2.592000543595803
    sum de = -4.726443845678996e-18
Info: CFL hydro = 0.006961992251411361 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006961992251411361 cfl multiplier : 0.6313396095310432        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9640e+04 |  512 |      1 | 2.607e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 680.9452866208602 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.3794899928917552, dt = 0.006961992251411361 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.4%)
   patch tree reduce : 2.07 us    (0.7%)
   gen split merge   : 812.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 926.00 ns  (0.3%)
   LB compute        : 294.87 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2413776061780124e-18,-1.8328112465215706e-17,1.2675407598528033e-18)
    sum a = (-5.606452802009443e-17,1.4963421127167643e-16,1.835328763966082e-16)
    sum e = 2.5920006303503498
    sum de = 6.437450399132683e-19
Info: CFL hydro = 0.00831485741573022 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00831485741573022 cfl multiplier : 0.7542264063540287         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9522e+04 |  512 |      1 | 2.623e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 955.6463526928485 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.3864519851431665, dt = 0.00831485741573022 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.4%)
   patch tree reduce : 1947.00 ns (0.6%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 296.23 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.925259419058525e-19,-1.6554140870594925e-17,3.495250963658769e-18)
    sum a = (-1.411683270280406e-16,-5.596646193359311e-17,3.18026854850828e-17)
    sum e = 2.5920007015725184
    sum de = 1.3654171109739321e-18
Info: CFL hydro = 0.009218217584035827 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009218217584035827 cfl multiplier : 0.8361509375693524        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6304e+04 |  512 |      1 | 3.140e-02 | 0.0% |   1.5% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 953.1803409226943 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.3947668425588966, dt = 0.009218217584035827 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.4%)
   patch tree reduce : 1572.00 ns (0.5%)
   gen split merge   : 811.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 862.00 ns  (0.3%)
   LB compute        : 273.59 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1983.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.825947785118248e-19,-1.8006104419987512e-17,2.9946748206222117e-18)
    sum a = (4.4964032497318837e-17,-3.796767587826988e-17,8.070107082591704e-17)
    sum e = 2.5920007647234606
    sum de = -1.1722935989999517e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010292814328006338
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.610040226140974e-19,-1.7921211389881898e-17,3.3342469410446718e-18)
    sum a = (5.50341022753642e-17,1.4279007663764443e-16,-4.0385663563347054e-17)
    sum e = 2.5920004537854044
    sum de = -1.0367683274392636e-18
Info: CFL hydro = 0.0049134526230442096 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0049134526230442096 cfl multiplier : 0.4453836458564508       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4939e+04 |  512 |      1 | 3.427e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 968.2891476937843 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.4039850601429325, dt = 0.0049134526230442096 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (0.3%)
   patch tree reduce : 1697.00 ns (0.1%)
   gen split merge   : 830.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 974.00 ns  (0.1%)
   LB compute        : 1289.81 us (98.6%)
   LB move op cnt    : 0
   LB apply          : 4.27 us    (0.3%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.81 us    (74.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3272399632401353e-19,-1.6516085374340684e-17,2.5321541738398957e-18)
    sum a = (7.929594481037583e-17,-1.391777318393572e-16,-1.0185992674327515e-16)
    sum e = 2.592000540175328
    sum de = -7.453889935837843e-20
Info: CFL hydro = 0.0069538722542174134 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0069538722542174134 cfl multiplier : 0.6302557639043006       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9126e+04 |  512 |      1 | 2.677e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 660.7490609716402 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.4088985127659766, dt = 0.0069538722542174134 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1179.00 ns (0.4%)
   gen split merge   : 794.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1021.00 ns (0.3%)
   LB compute        : 282.59 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.31 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.474666281232945e-19,-1.8014886457584643e-17,1.6158949178723958e-18)
    sum a = (-1.3770234952303894e-17,8.22525641347438e-17,1.9507832849097184e-17)
    sum e = 2.592000642285576
    sum de = -1.633079522306291e-18
Info: CFL hydro = 0.008317351445025751 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008317351445025751 cfl multiplier : 0.7535038426028672        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9772e+04 |  512 |      1 | 2.589e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 966.763070890143 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 1.415852385020194, dt = 0.008317351445025751 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.5%)
   patch tree reduce : 1375.00 ns (0.5%)
   gen split merge   : 780.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1079.00 ns (0.4%)
   LB compute        : 270.41 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1998.00 ns (64.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.844227895397843e-19,-1.6516085374340684e-17,2.0374327225347597e-18)
    sum a = (-1.4266712811128458e-16,6.908536243077634e-19,-6.798468038526906e-17)
    sum e = 2.592000751690993
    sum de = -3.211948935988307e-18
Info: CFL hydro = 0.009232966350249935 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009232966350249935 cfl multiplier : 0.8356692284019115        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9579e+04 |  512 |      1 | 2.615e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1145.0241535498849 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.4241697364652197, dt = 0.009232966350249935 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1381.00 ns (0.5%)
   gen split merge   : 746.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 971.00 ns  (0.3%)
   LB compute        : 278.50 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1968.00 ns (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5544206546924677e-18,-1.6952259908331602e-17,1.1299555041643928e-18)
    sum a = (1.2299536389370758e-16,1.2791330494810182e-16,-9.358139263504483e-17)
    sum e = 2.5920008706215114
    sum de = 6.776263578034403e-21
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010318659035063786
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.4249946628817083e-19,-1.649413028034785e-17,1.1153187748358383e-18)
    sum a = (4.8476847536171875e-17,-2.5479618415147344e-17,-7.461219142523845e-17)
    sum e = 2.59200046860025
    sum de = -1.5924219408380846e-18
Info: CFL hydro = 0.004922594875198133 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004922594875198133 cfl multiplier : 0.44522307613397044       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4391e+04 |  512 |      1 | 3.558e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 934.2244924695326 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.4334027028154697, dt = 0.004922594875198133 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.5%)
   patch tree reduce : 1602.00 ns (0.5%)
   gen split merge   : 640.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 281.90 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.834823084081229e-19,-1.7127900660274254e-17,8.79667432646114e-19)
    sum a = (-5.938999292354196e-17,7.47058664929412e-18,-1.8594500938995394e-17)
    sum e = 2.592000580037961
    sum de = 2.588532686809142e-18
Info: CFL hydro = 0.006969170347577544 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006969170347577544 cfl multiplier : 0.6301487174226469        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9524e+04 |  512 |      1 | 2.622e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 675.7568743223698 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.4383252976906677, dt = 0.006969170347577544 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.5%)
   patch tree reduce : 1238.00 ns (0.4%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1739.00 ns (0.6%)
   LB compute        : 276.59 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.37 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3026689102413336e-18,-1.6826384036106034e-17,8.15265823600475e-19)
    sum a = (3.732951447954491e-17,5.5947434185466e-17,-7.126330775486523e-17)
    sum e = 2.592000728811169
    sum de = 1.0638733817514012e-18
Info: CFL hydro = 0.00833792391070639 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00833792391070639 cfl multiplier : 0.7534324782817645         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8441e+04 |  512 |      1 | 2.776e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 903.6421109203683 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.4452944680382454, dt = 0.00833792391070639 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.92 us    (1.5%)
   patch tree reduce : 1370.00 ns (0.4%)
   gen split merge   : 714.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1303.00 ns (0.4%)
   LB compute        : 299.66 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.649777520821964e-19,-1.614870346819397e-17,-3.366447745567491e-20)
    sum a = (-4.051446678143833e-17,-1.0959982921221467e-16,-3.480028765157073e-17)
    sum e = 2.5920008928021026
    sum de = -1.9989977555201488e-18
Info: CFL hydro = 0.00925643381616163 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00925643381616163 cfl multiplier : 0.835621652187843          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9685e+04 |  512 |      1 | 2.601e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1154.0452324493024 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.4536323919489518, dt = 0.00925643381616163 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.6%)
   patch tree reduce : 1459.00 ns (0.5%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 277.52 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1965.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.293886872644201e-18,-1.766653229956505e-17,-2.473607256525678e-19)
    sum a = (-1.231358764952617e-16,3.8336521457349447e-17,-1.3161347012236035e-17)
    sum e = 2.592001063609429
    sum de = -1.7414997395548415e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010374318742333228
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5836941133495763e-18,-1.7209866344514158e-17,-1.741770790097963e-19)
    sum a = (-1.8219800668184405e-17,5.505752104228989e-17,-1.4730404396257058e-17)
    sum e = 2.5920004823578733
    sum de = -2.520770051028798e-18
Info: CFL hydro = 0.004939216664668094 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004939216664668094 cfl multiplier : 0.44520721739594765       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4948e+04 |  512 |      1 | 3.425e-02 | 0.0% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 972.8675337401296 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.4628888257651134, dt = 0.004939216664668094 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.5%)
   patch tree reduce : 1110.00 ns (0.4%)
   gen split merge   : 639.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 947.00 ns  (0.3%)
   LB compute        : 293.86 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.50 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2441219929271163e-18,-1.6857121167696e-17,-2.64924800846833e-19)
    sum a = (5.063137409333507e-17,-8.674311269274426e-17,4.079549198454657e-17)
    sum e = 2.5920006446882016
    sum de = -3.665958595716612e-18
Info: CFL hydro = 0.0069966753869742885 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0069966753869742885 cfl multiplier : 0.6301381449306317       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9804e+04 |  512 |      1 | 2.585e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 687.7721337327538 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.4678280424297814, dt = 0.0069966753869742885 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.5%)
   patch tree reduce : 1746.00 ns (0.6%)
   gen split merge   : 673.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 898.00 ns  (0.3%)
   LB compute        : 273.67 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.318364664277155e-19,-1.801927747638321e-17,1.331942368898442e-19)
    sum a = (4.6673602482893983e-17,7.369885951513666e-17,-7.248108363500094e-17)
    sum e = 2.592000849600731
    sum de = -9.825582188149884e-19
Info: CFL hydro = 0.008377401936757357 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008377401936757357 cfl multiplier : 0.7534254299537544        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0263e+04 |  512 |      1 | 2.527e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 996.8704525602352 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.4748247178167557, dt = 0.008377401936757357 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.3%)
   patch tree reduce : 1147.00 ns (0.4%)
   gen split merge   : 661.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 926.00 ns  (0.3%)
   LB compute        : 311.96 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.229485263598562e-19,-1.6765641609392534e-17,-8.05020113070487e-19)
    sum a = (-6.686057957283608e-17,-1.3442372215344278e-17,4.6111552076677495e-17)
    sum e = 2.592001060275223
    sum de = 1.0367683274392636e-18
Info: CFL hydro = 0.009310102003717511 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009310102003717511 cfl multiplier : 0.835616953302503         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0160e+04 |  512 |      1 | 2.540e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1187.4932362739737 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.483202119753513, dt = 0.009310102003717511 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.5%)
   patch tree reduce : 1711.00 ns (0.6%)
   gen split merge   : 682.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 837.00 ns  (0.3%)
   LB compute        : 273.24 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.42 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1941.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3231603313013097e-18,-1.7292929783453702e-17,7.318364664277155e-21)
    sum a = (1.1791349147083351e-16,-5.545564008002657e-17,-3.704848927643667e-17)
    sum e = 2.5920012576971487
    sum de = 2.913793338554793e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010449515282598378
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.444863310222204e-19,-1.73694066941954e-17,-3.776276166767012e-19)
    sum a = (4.9507273280902094e-17,1.3695294898141695e-16,-3.093619110883239e-17)
    sum e = 2.5920004904179836
    sum de = 2.9070170749767588e-18
Info: CFL hydro = 0.004971855907178788 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004971855907178788 cfl multiplier : 0.4452056511008344        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4786e+04 |  512 |      1 | 3.463e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 967.9120069556012 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.4925122217572304, dt = 0.004971855907178788 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 1744.00 ns (0.6%)
   gen split merge   : 682.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1083.00 ns (0.4%)
   LB compute        : 277.54 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1810.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.205973235307028e-19,-1.5938849361445823e-17,-4.164149493973701e-19)
    sum a = (1.9287696439995726e-16,2.669739429528306e-18,-3.861754666045769e-17)
    sum e = 2.592000706400993
    sum de = 3.3881317890172014e-20
Info: CFL hydro = 0.007043023205659475 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007043023205659475 cfl multiplier : 0.6301371007338896        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9549e+04 |  512 |      1 | 2.619e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 683.4063645338821 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.4974840776644092, dt = 0.0025159223355908367 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.5%)
   patch tree reduce : 1565.00 ns (0.5%)
   gen split merge   : 716.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1004.00 ns (0.3%)
   LB compute        : 278.33 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.693158196453993e-19,-1.6272475310578558e-17,-5.730279532129012e-19)
    sum a = (7.447167882368433e-17,-8.093525849517391e-17,-6.686057957283608e-17)
    sum e = 2.592000539732076
    sum de = -2.812149384884277e-19
Info: CFL hydro = 0.008425324747063489 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008425324747063489 cfl multiplier : 0.7534247338225931        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9653e+04 |  512 |      1 | 2.605e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 347.66836889525746 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 201                                                     [SPH][rank=0]
Info: time since start : 1736.8559680960002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14952648700874405 max=0.15040895984518035 delta=0.0008824728364363044
Number of particle pairs: 130816
Distance min=0.144713 max=1.919135 mean=0.806367
---------------- t = 1.5, dt = 0.008425324747063489 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 10.14 us   (1.4%)
   patch tree reduce : 1896.00 ns (0.3%)
   gen split merge   : 451.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 868.00 ns  (0.1%)
   LB compute        : 706.65 us  (96.2%)
   LB move op cnt    : 0
   LB apply          : 7.30 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.85 us    (82.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.835882108788495e-19,-1.7215172158895758e-17,-1.1270281582986818e-18)
    sum a = (-7.634518017773928e-17,8.449491106787832e-17,-9.030276526544867e-17)
    sum e = 2.5920011579883986
    sum de = -1.6534083130403943e-18
Info: CFL hydro = 0.009359956302364698 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009359956302364698 cfl multiplier : 0.8356164892150622        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4259e+04 |  512 |      1 | 3.591e-02 | 0.1% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 844.7044444732129 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.5084253247470636, dt = 0.009359956302364698 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.94 us    (0.8%)
   patch tree reduce : 1256.00 ns (0.2%)
   gen split merge   : 832.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 902.00 ns  (0.1%)
   LB compute        : 611.90 us  (97.3%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (0.5%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1904.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.50341022753642e-19,-1.5636417941694568e-17,-1.9854723334183923e-18)
    sum a = (-2.937884310827421e-17,-2.997602166487923e-17,-8.943627088919825e-17)
    sum e = 2.592001351158938
    sum de = 1.7584403984999275e-18
Info: CFL hydro = 0.009975669436516591 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009975669436516591 cfl multiplier : 0.8904109928100414        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8265e+04 |  512 |      1 | 2.803e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1202.0765844552789 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.5177852810494283, dt = 0.009975669436516591 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.5%)
   patch tree reduce : 1320.00 ns (0.4%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 866.00 ns  (0.3%)
   LB compute        : 290.54 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.566659550508944e-19,-1.6330198911868042e-17,-2.8717262942623554e-18)
    sum a = (1.1378007910844977e-16,9.414344304126131e-17,-4.416779442184548e-17)
    sum e = 2.5920014861265304
    sum de = -1.294266343404571e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010154320026237848
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.927345865710862e-20,-1.5867678265085727e-17,-2.6591278007651043e-18)
    sum a = (1.8534783083334893e-16,-3.4144562177651494e-17,-1.0234001146525173e-17)
    sum e = 2.5920004921977915
    sum de = -4.472333961502706e-19
Info: CFL hydro = 0.0051920057333695166 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0051920057333695166 cfl multiplier : 0.4634703309366805       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4952e+04 |  512 |      1 | 3.424e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1048.7561179966747 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.5277609504859448, dt = 0.0051920057333695166 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.3%)
   patch tree reduce : 1821.00 ns (0.5%)
   gen split merge   : 688.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 966.00 ns  (0.3%)
   LB compute        : 314.27 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.38 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4051260155412136e-18,-1.6617078806707708e-17,-2.5112968345467055e-18)
    sum a = (-1.5298309494204965e-17,-4.1170192255357564e-17,-1.5514933088267568e-17)
    sum e = 2.592000759028752
    sum de = 2.202285662861181e-19
Info: CFL hydro = 0.007195021347652999 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007195021347652999 cfl multiplier : 0.642313553957787         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9765e+04 |  512 |      1 | 2.590e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 721.5597644143579 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.5329529562193143, dt = 0.007195021347652999 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.91 us    (1.6%)
   patch tree reduce : 1437.00 ns (0.5%)
   gen split merge   : 779.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 962.00 ns  (0.3%)
   LB compute        : 293.21 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.48 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.059699203387332e-18,-1.7012270498578673e-17,-2.6572982095990347e-18)
    sum a = (-5.797901221626933e-17,-8.454174860172969e-17,-3.23413171243736e-17)
    sum e = 2.592001000903559
    sum de = 6.2172218328465645e-19
Info: CFL hydro = 0.008528583809079927 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008528583809079927 cfl multiplier : 0.7615423693051913        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9374e+04 |  512 |      1 | 2.643e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 980.1345254124833 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.5401479775669673, dt = 0.008528583809079927 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.49 us    (1.5%)
   patch tree reduce : 1731.00 ns (0.6%)
   gen split merge   : 709.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 272.93 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9905951886833862e-19,-1.7869982837231955e-17,-3.1110368187842186e-18)
    sum a = (-6.640354769955197e-17,-1.0852256593363307e-16,-1.2786646741425044e-17)
    sum e = 2.5920011913195435
    sum de = 4.946672411965114e-19
Info: CFL hydro = 0.009412978495345581 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009412978495345581 cfl multiplier : 0.8410282462034608        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0353e+04 |  512 |      1 | 2.516e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1220.5268326620171 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.5486765613760471, dt = 0.009412978495345581 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.5%)
   patch tree reduce : 1569.00 ns (0.5%)
   gen split merge   : 731.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 796.00 ns  (0.3%)
   LB compute        : 293.76 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.3418766925686897e-19,-1.8840397991715107e-17,-2.9626569752159993e-18)
    sum a = (-7.406185040248481e-18,6.210656988692165e-17,6.345314898514864e-17)
    sum e = 2.592001309565934
    sum de = 6.060520737604519e-19
Info: CFL hydro = 0.010002198129642249 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010002198129642249 cfl multiplier : 0.8940188308023073        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0218e+04 |  512 |      1 | 2.532e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1338.144746187719 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.5580895398713928, dt = 0.010002198129642249 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1157.00 ns (0.4%)
   gen split merge   : 718.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 882.00 ns  (0.3%)
   LB compute        : 294.55 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.50 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.33 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.8102520310824276e-19,-1.745869074309958e-17,-2.032309867269766e-18)
    sum a = (-2.2812220862311606e-16,1.1943571132100317e-18,-3.354738362104648e-18)
    sum e = 2.5920013586430266
    sum de = 2.9434394917086937e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011126364910963488
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3465790982269965e-18,-1.766653229956505e-17,-2.2903279614646874e-18)
    sum a = (-2.2704494534453446e-17,-1.6826384036106035e-16,1.769873310408787e-17)
    sum e = 2.5920004770431113
    sum de = 4.362219678359647e-20
Info: CFL hydro = 0.005195827874569278 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005195827874569278 cfl multiplier : 0.4646729436007691        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4819e+04 |  512 |      1 | 3.455e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1042.1833546903702 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.568091738001035, dt = 0.005195827874569278 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.4%)
   patch tree reduce : 1784.00 ns (0.6%)
   gen split merge   : 772.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 941.00 ns  (0.3%)
   LB compute        : 300.67 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.512815038853034e-19,-1.9501978157365762e-17,-2.3157249738386865e-18)
    sum a = (2.3219707406818556e-17,8.166124026987021e-17,1.250796341500937e-16)
    sum e = 2.5920007149467916
    sum de = 1.6093625997831706e-20
Info: CFL hydro = 0.007181776879038182 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007181776879038182 cfl multiplier : 0.6431152957338461        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0298e+04 |  512 |      1 | 2.522e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 741.565318908088 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 1.5732875658756043, dt = 0.007181776879038182 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 2.06 us    (0.7%)
   gen split merge   : 828.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 901.00 ns  (0.3%)
   LB compute        : 277.16 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1981.00 ns (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.5760643618255584e-19,-1.8234437397512958e-17,-1.0757996056487417e-18)
    sum a = (-4.9589238965142e-17,-2.3489023226463956e-17,5.912067710389657e-17)
    sum e = 2.5920008967763537
    sum de = -9.215718466126788e-19
Info: CFL hydro = 0.008496909381927912 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008496909381927912 cfl multiplier : 0.7620768638225641        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0369e+04 |  512 |      1 | 2.514e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1028.5593604800351 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.5804693427546423, dt = 0.008496909381927912 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1229.00 ns (0.4%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 801.00 ns  (0.3%)
   LB compute        : 293.30 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0304257447302234e-18,-1.8735013540549518e-17,-9.474537853489812e-19)
    sum a = (1.2257382608904522e-16,4.376967538410881e-17,1.3878546749335196e-16)
    sum e = 2.592001016387438
    sum de = 3.2356658585114273e-19
Info: CFL hydro = 0.009356037177365389 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009356037177365389 cfl multiplier : 0.8413845758817095        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0172e+04 |  512 |      1 | 2.538e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1205.1747821874867 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.5889662521365702, dt = 0.009356037177365389 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.5%)
   patch tree reduce : 1100.00 ns (0.4%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1424.00 ns (0.5%)
   LB compute        : 287.95 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.601694439531627e-19,-1.7956339540270427e-17,9.508385290062093e-19)
    sum a = (7.587680483922554e-18,-1.232763890968158e-16,-1.25319676511082e-17)
    sum e = 2.592001066687351
    sum de = 2.879912020664621e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010492822687863845
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.498707821878113e-19,-1.8688176006698142e-17,1.7554927238434826e-19)
    sum a = (2.0702189962307216e-16,8.318346012003985e-17,2.4818038249496688e-17)
    sum e = 2.5920004732629205
    sum de = -2.9002408113987244e-18
Info: CFL hydro = 0.004960171790504496 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004960171790504496 cfl multiplier : 0.44712819196056985       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4729e+04 |  512 |      1 | 3.476e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 968.9608964002077 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.5983222893139355, dt = 0.004960171790504496 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.3%)
   patch tree reduce : 1301.00 ns (0.4%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 904.00 ns  (0.3%)
   LB compute        : 290.74 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.499953369317076e-18,-1.7461618088965292e-17,5.217994005629612e-19)
    sum a = (1.2887347439205498e-16,6.824228682145161e-17,-3.0444397003392963e-18)
    sum e = 2.592000639910608
    sum de = -1.5178830414797062e-18
Info: CFL hydro = 0.006995974543377529 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006995974543377529 cfl multiplier : 0.6314187946403799        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9708e+04 |  512 |      1 | 2.598e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 687.3522310599922 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.60328246110444, dt = 0.006995974543377529 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.87 us    (1.6%)
   patch tree reduce : 1462.00 ns (0.5%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1034.00 ns (0.3%)
   LB compute        : 280.97 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1911.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.1498241515048874e-18,-1.7010806825645818e-17,2.345535874900828e-19)
    sum a = (-2.1849709541665873e-17,7.803133139638874e-17,5.386901862081128e-17)
    sum e = 2.592000771721285
    sum de = -4.001383642829315e-18
Info: CFL hydro = 0.008345013401501124 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008345013401501124 cfl multiplier : 0.7542791964269199        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9579e+04 |  512 |      1 | 2.615e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 963.0845446179671 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.6102784356478177, dt = 0.008345013401501124 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.59 us    (1.6%)
   patch tree reduce : 1273.00 ns (0.4%)
   gen split merge   : 766.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1341.00 ns (0.5%)
   LB compute        : 276.49 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.911556850309193e-18,-1.623213282536673e-17,1.075250728298921e-18)
    sum a = (2.9741833995622357e-17,2.5163465061650568e-17,4.027588809338289e-17)
    sum e = 2.592000856850743
    sum de = 2.4462311516704194e-18
Info: CFL hydro = 0.009238771118362547 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009238771118362547 cfl multiplier : 0.83618613095128          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9587e+04 |  512 |      1 | 2.614e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1149.2788153275048 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.6186234490493188, dt = 0.009238771118362547 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 1991.00 ns (0.7%)
   gen split merge   : 690.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 944.00 ns  (0.3%)
   LB compute        : 282.45 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1981.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.655102700199752e-18,-1.6276043013352393e-17,1.198748132008598e-18)
    sum a = (-1.1109863029545863e-16,-8.723490679818369e-17,-5.0894469303015835e-17)
    sum e = 2.5920008962469363
    sum de = 5.183841637196318e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010294224757676303
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2511289707316527e-18,-1.6680016742820492e-17,8.2240122914814525e-19)
    sum a = (-1.1629759655296112e-16,8.530285852681451e-17,-3.3372474705570257e-17)
    sum e = 2.5920004740244895
    sum de = -2.23955511254037e-18
Info: CFL hydro = 0.004917509625636514 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004917509625636514 cfl multiplier : 0.44539537698376          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4677e+04 |  512 |      1 | 3.489e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 953.394879381689 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 1.6278622201676813, dt = 0.004917509625636514 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 1398.00 ns (0.5%)
   gen split merge   : 779.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 278.09 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1894.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7271340607694085e-18,-1.545345882508764e-17,6.218780373469512e-19)
    sum a = (-3.161533534967731e-17,4.2592882346093044e-17,-1.2435163982511473e-16)
    sum e = 2.5920005930085814
    sum de = -5.285485590866834e-19
Info: CFL hydro = 0.006955550398892707 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006955550398892707 cfl multiplier : 0.63026358465584          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9708e+04 |  512 |      1 | 2.598e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 681.4367325086585 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.6327797297933178, dt = 0.006955550398892707 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.08 us    (1.4%)
   patch tree reduce : 1499.00 ns (0.5%)
   gen split merge   : 755.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 865.00 ns  (0.3%)
   LB compute        : 286.06 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4929463915125396e-18,-1.518707035130795e-17,-3.232887590444433e-19)
    sum a = (1.1400255739424381e-16,4.7797703295326954e-17,-2.782149510771603e-17)
    sum e = 2.5920006939946543
    sum de = 2.710505431213761e-20
Info: CFL hydro = 0.008308372845793485 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008308372845793485 cfl multiplier : 0.7535090564372267        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0039e+04 |  512 |      1 | 2.555e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 980.0074203529589 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.6397352801922105, dt = 0.008308372845793485 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.5%)
   patch tree reduce : 1192.00 ns (0.4%)
   gen split merge   : 739.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 892.00 ns  (0.3%)
   LB compute        : 293.39 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1872.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.117623346982068e-18,-1.467771217067426e-17,-1.7618962929247251e-19)
    sum a = (7.142723912334503e-17,-5.4142725459255245e-17,-5.459500039550758e-17)
    sum e = 2.5920007700955185
    sum de = -2.507217523872729e-19
Info: CFL hydro = 0.009208316721976903 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009208316721976903 cfl multiplier : 0.8356727042914844        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9467e+04 |  512 |      1 | 2.630e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1137.2261253269148 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.648043653038004, dt = 0.009208316721976903 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1269.00 ns (0.4%)
   gen split merge   : 640.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1220.00 ns (0.4%)
   LB compute        : 273.20 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1991.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.580143993764384e-18,-1.5743266065793014e-17,-7.376911581591372e-19)
    sum a = (-4.857052260387462e-17,-1.4142593346422316e-16,4.7216625140983345e-17)
    sum e = 2.592000825678609
    sum de = 1.2874900798265365e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01024082448176437
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.75170511376821e-18,-1.5989163118512727e-17,-3.4103579335531544e-19)
    sum a = (4.4261469489548234e-17,-6.811348360336034e-17,-1.6963969291794445e-18)
    sum e = 2.5920004807652384
    sum de = -8.063753657860939e-19
Info: CFL hydro = 0.004906094137975236 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004906094137975236 cfl multiplier : 0.44522423476382816       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4776e+04 |  512 |      1 | 3.465e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 956.7079823591632 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.657251969759981, dt = 0.004906094137975236 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.4%)
   patch tree reduce : 1925.00 ns (0.7%)
   gen split merge   : 769.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 994.00 ns  (0.3%)
   LB compute        : 273.17 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1985.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.492323617793058e-18,-1.6229205479501017e-17,-4.63069524132137e-19)
    sum a = (-1.2444732744310017e-16,-4.497574188078168e-17,1.4902239598574285e-16)
    sum e = 2.592000577263906
    sum de = -2.913793338554793e-19
Info: CFL hydro = 0.006944132619120374 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006944132619120374 cfl multiplier : 0.6301494898425521        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9756e+04 |  512 |      1 | 2.592e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 681.4867287779487 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.6621580638979563, dt = 0.006944132619120374 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.4%)
   patch tree reduce : 1395.00 ns (0.4%)
   gen split merge   : 722.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1370.00 ns (0.4%)
   LB compute        : 284.13 us  (90.8%)
   LB move op cnt    : 0
   LB apply          : 15.04 us   (4.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1890.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2745477376573397e-18,-1.6510230682609262e-17,1.0452454331753847e-18)
    sum a = (4.0186604044478714e-17,-7.012749755896941e-17,7.886562496811634e-17)
    sum e = 2.592000677715506
    sum de = -6.776263578034403e-19
Info: CFL hydro = 0.008305440751579268 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008305440751579268 cfl multiplier : 0.7534329932283681        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0049e+04 |  512 |      1 | 2.554e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 978.8962585662005 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.6691021965170767, dt = 0.008305440751579268 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.3%)
   patch tree reduce : 1629.00 ns (0.5%)
   gen split merge   : 712.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1383.00 ns (0.4%)
   LB compute        : 299.80 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.1088413093849354e-18,-1.7227430419708424e-17,1.3469450164602104e-18)
    sum a = (-1.5409548637101977e-16,-3.7774471051132965e-17,2.1791162624351656e-17)
    sum e = 2.592000773539855
    sum de = 7.115076756936123e-19
Info: CFL hydro = 0.009218741566437592 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009218741566437592 cfl multiplier : 0.8356219954855787        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9716e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1151.3786893604117 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.677407637268656, dt = 0.009218741566437592 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.4%)
   patch tree reduce : 1545.00 ns (0.5%)
   gen split merge   : 736.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1238.00 ns (0.4%)
   LB compute        : 293.28 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.69 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.328298987947402e-19,-1.7274267953559796e-17,1.1671876843939027e-18)
    sum a = (1.2060664966728752e-16,4.7797703295326954e-17,7.421992707923319e-17)
    sum e = 2.592000866354699
    sum de = 3.503328269843786e-18
Info: CFL hydro = 0.009836635400369971 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009836635400369971 cfl multiplier : 0.8904146636570524        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9523e+04 |  512 |      1 | 2.623e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1265.4490118116432 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.6866263788350935, dt = 0.009836635400369971 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1541.00 ns (0.5%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 883.00 ns  (0.3%)
   LB compute        : 293.72 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1897.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.583254298746702e-18,-1.6428264998369357e-17,2.23758999610274e-18)
    sum a = (6.707134847516727e-17,-6.30901580978005e-17,-7.445118740262436e-17)
    sum e = 2.5920009618726536
    sum de = -1.4704491964334654e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01073101937920734
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.1423228277240036e-18,-1.700787947978011e-17,1.504335596521321e-18)
    sum a = (-1.3020834410681914e-17,2.3137741722578652e-17,1.50377757121567e-17)
    sum e = 2.592000502699158
    sum de = -1.6466320494623599e-18
Info: CFL hydro = 0.00513163251498297 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00513163251498297 cfl multiplier : 0.46347155455235073        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4765e+04 |  512 |      1 | 3.468e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1021.2214259272511 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.6964630142354635, dt = 0.00513163251498297 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.5%)
   patch tree reduce : 1312.00 ns (0.4%)
   gen split merge   : 632.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 950.00 ns  (0.3%)
   LB compute        : 276.06 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.8184851913297393e-18,-1.6624397171371985e-17,1.9663073659538163e-18)
    sum a = (3.6533276404071555e-17,3.9320109668228297e-17,2.9015852220926066e-17)
    sum e = 2.5920006241147524
    sum de = 7.521652571618187e-19
Info: CFL hydro = 0.007116225594301627 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007116225594301627 cfl multiplier : 0.6423143697015671        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9896e+04 |  512 |      1 | 2.573e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 717.8949168760713 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.7015946467504466, dt = 0.007116225594301627 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.2%)
   patch tree reduce : 1486.00 ns (0.4%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 922.00 ns  (0.3%)
   LB compute        : 326.67 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.63 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.0206550151803956e-18,-1.6384354810383694e-17,2.223456404344855e-18)
    sum a = (6.533835972266644e-17,-1.976543928527974e-17,9.215284785257793e-18)
    sum e = 2.5920007645622287
    sum de = -2.256495771485456e-18
Info: CFL hydro = 0.00843882817524846 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00843882817524846 cfl multiplier : 0.7615429131343779         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9633e+04 |  512 |      1 | 2.608e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 982.3714420759071 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.7087108723447482, dt = 0.00843882817524846 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.5%)
   patch tree reduce : 1512.00 ns (0.5%)
   gen split merge   : 667.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1284.00 ns (0.4%)
   LB compute        : 279.13 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.649668458075017e-18,-1.654535883299779e-17,2.1279403105312502e-18)
    sum a = (-4.978829848401034e-17,-7.273869007118349e-17,1.687614891582312e-17)
    sum e = 2.592000908530582
    sum de = -7.995991022080595e-19
Info: CFL hydro = 0.009314959845294143 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009314959845294143 cfl multiplier : 0.8410286087562518        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8160e+04 |  512 |      1 | 2.819e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1077.56133102179 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 1.7171497005199967, dt = 0.009314959845294143 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.5%)
   patch tree reduce : 1237.00 ns (0.4%)
   gen split merge   : 665.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 290.27 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.8541622190680903e-18,-1.7408925863382495e-17,2.259819528770482e-18)
    sum a = (1.5198779734770794e-16,-7.428432868827884e-17,6.56091392152447e-17)
    sum e = 2.592001047424677
    sum de = 2.944286524655948e-18
Info: CFL hydro = 0.00990036613361954 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00990036613361954 cfl multiplier : 0.8940190725041678         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9740e+04 |  512 |      1 | 2.594e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1292.9051319949062 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.726464660365291, dt = 0.00990036613361954 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.3%)
   patch tree reduce : 1724.00 ns (0.6%)
   gen split merge   : 714.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 936.00 ns  (0.3%)
   LB compute        : 282.49 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1965.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.095045479269755e-18,-1.817003578846732e-17,3.0664405341112796e-18)
    sum a = (-1.4266712811128458e-16,5.775067923874388e-17,-5.608062842235583e-17)
    sum e = 2.59200117715645
    sum de = -6.505213034913027e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01079324839481516
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.801158606625554e-18,-1.738550709645681e-17,2.596098385094017e-18)
    sum a = (-6.177870714996203e-17,-7.990483275044368e-17,-5.564738123423063e-17)
    sum e = 2.592000525085599
    sum de = 3.4220131069073734e-19
Info: CFL hydro = 0.005148469947192145 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005148469947192145 cfl multiplier : 0.4646730241680559        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4667e+04 |  512 |      1 | 3.491e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1021.012341016807 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.7363650264989103, dt = 0.005148469947192145 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.4%)
   patch tree reduce : 1337.00 ns (0.4%)
   gen split merge   : 748.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 934.00 ns  (0.3%)
   LB compute        : 306.24 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.6796737531985535e-18,-1.869842171722813e-17,2.27720064484814e-18)
    sum a = (-4.028027911218146e-17,-6.894484982922222e-17,1.6955845907017098e-16)
    sum e = 2.592000697450325
    sum de = -1.1180834903756764e-18
Info: CFL hydro = 0.007127609431497805 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007127609431497805 cfl multiplier : 0.6431153494453706        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9738e+04 |  512 |      1 | 2.594e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 714.5079707656926 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.7415134964461025, dt = 0.007127609431497805 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.72 us    (1.6%)
   patch tree reduce : 1680.00 ns (0.6%)
   gen split merge   : 706.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1684.00 ns (0.6%)
   LB compute        : 285.49 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.32 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.436704046344552e-18,-1.900286568726206e-17,3.972362599990488e-18)
    sum a = (-1.7151904896373082e-16,1.892236367595501e-17,9.427407585051866e-17)
    sum e = 2.592000882707638
    sum de = 1.5212711732687234e-18
Info: CFL hydro = 0.008451351673079832 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008451351673079832 cfl multiplier : 0.7620768996302472        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9081e+04 |  512 |      1 | 2.683e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 956.2750230453227 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.7486411058776004, dt = 0.008451351673079832 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1256.00 ns (0.4%)
   gen split merge   : 823.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 954.00 ns  (0.3%)
   LB compute        : 298.76 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5954034968124198e-18,-1.832079410055143e-17,4.545070374749327e-18)
    sum a = (-3.264576109440753e-17,-5.676709102786503e-17,-2.225551286230004e-17)
    sum e = 2.592001057218529
    sum de = 7.657177843178875e-19
Info: CFL hydro = 0.009337817473755523 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009337817473755523 cfl multiplier : 0.8413845997534981        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9469e+04 |  512 |      1 | 2.630e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1156.889422751554 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.75709245755068, dt = 0.009337817473755523 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.87 us    (1.5%)
   patch tree reduce : 1189.00 ns (0.4%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1245.00 ns (0.4%)
   LB compute        : 298.67 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.949612346563434e-18,-1.9158015018144737e-17,3.943455059566593e-18)
    sum a = (-2.4589705271971242e-17,1.1568870861289326e-16,1.3371603629040719e-16)
    sum e = 2.5920012047458867
    sum de = 1.370499308657458e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01038394732355249
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.885210737517795e-18,-1.850375321715836e-17,4.595201172699625e-18)
    sum a = (4.655650864826555e-17,-9.395609290585582e-17,-9.095483155703577e-17)
    sum e = 2.592000526656862
    sum de = -9.41900637346782e-19
Info: CFL hydro = 0.004959589316291144 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004959589316291144 cfl multiplier : 0.4471281999178327        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4553e+04 |  512 |      1 | 3.518e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 955.518628313585 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 1.7664302750244356, dt = 0.004959589316291144 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.5%)
   patch tree reduce : 1348.00 ns (0.5%)
   gen split merge   : 738.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 923.00 ns  (0.3%)
   LB compute        : 277.63 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.38 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.655102700199752e-18,-1.9955716766550946e-17,3.076320326408054e-18)
    sum a = (-9.924873423106107e-17,4.5900783174346314e-18,-1.2647012343630637e-16)
    sum e = 2.592000715801032
    sum de = -5.327837238229549e-19
Info: CFL hydro = 0.007001914726372389 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007001914726372389 cfl multiplier : 0.6314187999452218        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0099e+04 |  512 |      1 | 2.547e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 700.8881532575554 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.7713898643407266, dt = 0.007001914726372389 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 1709.00 ns (0.6%)
   gen split merge   : 776.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 908.00 ns  (0.3%)
   LB compute        : 277.71 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.36 us    (69.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4373268200640332e-18,-1.976516484660483e-17,2.2154976827724534e-18)
    sum a = (-5.077188669488919e-17,-6.262178275928675e-17,-1.776898940486493e-18)
    sum e = 2.5920009134637145
    sum de = 3.350015306390758e-19
Info: CFL hydro = 0.008363104159678475 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008363104159678475 cfl multiplier : 0.7542791999634811        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9944e+04 |  512 |      1 | 2.567e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 981.8707420301629 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.778391779067099, dt = 0.008363104159678475 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.85 us    (1.3%)
   patch tree reduce : 1507.00 ns (0.5%)
   gen split merge   : 636.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 874.00 ns  (0.3%)
   LB compute        : 274.13 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2909595267784901e-18,-2.027187012004772e-17,2.684650597531771e-18)
    sum a = (2.2505435015585106e-17,-2.421500500116025e-16,3.7270967562230696e-17)
    sum e = 2.5920010843781798
    sum de = 1.4921544157068568e-18
Info: CFL hydro = 0.009272673469969314 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009272673469969314 cfl multiplier : 0.8361861333089875        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9813e+04 |  512 |      1 | 2.584e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1165.088617728218 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.7867548832267777, dt = 0.009272673469969314 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.5%)
   patch tree reduce : 1360.00 ns (0.5%)
   gen split merge   : 676.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1156.00 ns (0.4%)
   LB compute        : 274.01 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.38 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1982.00 ns (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.926193579637747e-18,-2.3273863305334208e-17,3.19589554405547e-18)
    sum a = (2.4777055407376735e-17,-6.721186107672139e-17,-3.4446078801819713e-17)
    sum e = 2.5920012103263077
    sum de = 4.0318768289304696e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010059651497228417
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.779826286352204e-18,-2.2288079585056074e-17,2.822944819797033e-18)
    sum a = (-3.2083710688191046e-18,6.786758655064062e-17,-8.755691484341189e-18)
    sum e = 2.592000525076496
    sum de = -4.895850435129856e-19
Info: CFL hydro = 0.004942958925064998 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004942958925064998 cfl multiplier : 0.4453953777696625        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5061e+04 |  512 |      1 | 3.400e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 981.9309521369173 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.796027556696747, dt = 0.004942958925064998 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.3%)
   patch tree reduce : 1691.00 ns (0.5%)
   gen split merge   : 816.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 922.00 ns  (0.3%)
   LB compute        : 319.42 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6627324517237696e-18,-2.1518919458840547e-17,2.8348600322660593e-18)
    sum a = (-1.2877979932435223e-16,4.215378046623641e-19,-2.50639353022164e-17)
    sum e = 2.5920007184408065
    sum de = 1.4840017235895342e-18
Info: CFL hydro = 0.006997691333508418 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006997691333508418 cfl multiplier : 0.630263585179775         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9829e+04 |  512 |      1 | 2.582e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 689.1684318450602 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.8009705156218119, dt = 0.006997691333508418 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.5%)
   patch tree reduce : 1492.00 ns (0.5%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 983.00 ns  (0.3%)
   LB compute        : 270.97 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8149544367407343e-19,-2.160088514308045e-17,2.654416603512476e-18)
    sum a = (-7.739902468939519e-17,8.379234806010771e-17,-1.3529021652969318e-16)
    sum e = 2.5920009047555013
    sum de = -2.2836008257975937e-18
Info: CFL hydro = 0.00837312264964346 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00837312264964346 cfl multiplier : 0.7535090567865167         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9406e+04 |  512 |      1 | 2.638e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 954.8196588482691 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.8079682069553202, dt = 0.00837312264964346 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1272.00 ns (0.4%)
   gen split merge   : 755.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1202.00 ns (0.4%)
   LB compute        : 295.45 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.367506770274758e-20,-2.0788546665345686e-17,1.0556741028219795e-18)
    sum a = (1.0075924469776787e-16,4.2153780466236414e-17,1.1089371608485887e-16)
    sum e = 2.59200105243114
    sum de = 6.860966872759833e-19
Info: CFL hydro = 0.009292088497641727 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009292088497641727 cfl multiplier : 0.8356727045243444        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9722e+04 |  512 |      1 | 2.596e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1161.0917224956575 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.8163413296049638, dt = 0.009292088497641727 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.59 us    (1.6%)
   patch tree reduce : 1626.00 ns (0.6%)
   gen split merge   : 725.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 277.12 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1935.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.569057384021022e-18,-2.058216878181307e-17,3.1514707835543498e-18)
    sum a = (-1.9987917571073765e-17,1.6205786712575333e-17,-1.001737755246257e-17)
    sum e = 2.5920011462053036
    sum de = -1.8228149024912543e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010223713160306389
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.782037597132586e-19,-2.0612905913403034e-17,2.602593433733563e-18)
    sum a = (1.022229176306233e-17,1.6627324517237694e-17,5.720619290772167e-17)
    sum e = 2.592000521647244
    sum de = 3.733721231496956e-18
Info: CFL hydro = 0.004945434176171771 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004945434176171771 cfl multiplier : 0.44522423484144813       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4593e+04 |  512 |      1 | 3.508e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 953.4565475281134 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.8256334181026055, dt = 0.004945434176171771 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.3%)
   patch tree reduce : 1480.00 ns (0.5%)
   gen split merge   : 722.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 310.74 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.52 us    (70.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3699978651526833e-18,-2.041238272160184e-17,3.032730316876453e-18)
    sum a = (-5.1790603056156567e-17,1.9578089149874244e-17,7.57011640872829e-18)
    sum e = 2.5920006977493664
    sum de = 4.8890741715518216e-18
Info: CFL hydro = 0.006995813610916289 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006995813610916289 cfl multiplier : 0.6301494898942988        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9507e+04 |  512 |      1 | 2.625e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 678.3185985747101 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.8305788522787774, dt = 0.006995813610916289 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.4%)
   patch tree reduce : 2.15 us    (0.7%)
   gen split merge   : 773.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 967.00 ns  (0.3%)
   LB compute        : 287.70 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1877.00 ns (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.14742631799281e-19,-2.0503130443438878e-17,2.9227718877956887e-18)
    sum a = (2.6048108982268393e-16,-1.1020871715228253e-16,3.660938739658004e-17)
    sum e = 2.5920008550681537
    sum de = -3.3881317890172014e-19
Info: CFL hydro = 0.008359742107550793 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008359742107550793 cfl multiplier : 0.7534329932628658        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9227e+04 |  512 |      1 | 2.663e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 945.7405505212623 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.8375746658896936, dt = 0.008359742107550793 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1929.00 ns (0.7%)
   gen split merge   : 689.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 933.00 ns  (0.3%)
   LB compute        : 274.91 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1869.00 ns (64.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.1392670541151585e-18,-2.1758961819828837e-17,3.3477859156735845e-18)
    sum a = (-2.51616354704845e-17,5.995204332975845e-18,-3.155678843236309e-18)
    sum e = 2.5920009704077693
    sum de = -1.1248597539537109e-18
Info: CFL hydro = 0.00926793031573843 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00926793031573843 cfl multiplier : 0.8356219955085772         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9872e+04 |  512 |      1 | 2.576e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1168.07540820666 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 1.8459344079972444, dt = 0.00926793031573843 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.6%)
   patch tree reduce : 1347.00 ns (0.5%)
   gen split merge   : 1148.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 924.00 ns  (0.3%)
   LB compute        : 272.47 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1982.00 ns (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.441406452002859e-18,-2.1246676293329437e-17,3.200686785921614e-18)
    sum a = (-2.306163073007017e-17,3.0069696732581974e-17,7.025630077706068e-18)
    sum e = 2.592001036406813
    sum de = 1.819426770702237e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011240909820942283
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.7282863468425235e-18,-2.1097381654178182e-17,3.2800910425290207e-18)
    sum a = (-8.161440273601883e-18,7.707116195243557e-17,4.7534242167412975e-17)
    sum e = 2.592000519814754
    sum de = -1.128247885742728e-18
Info: CFL hydro = 0.004938168438014971 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004938168438014971 cfl multiplier : 0.4452073318361924        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.3695e+04 |  512 |      1 | 3.739e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 892.4272687801332 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.8552023383129828, dt = 0.004938168438014971 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.4%)
   patch tree reduce : 1681.00 ns (0.5%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 869.00 ns  (0.3%)
   LB compute        : 309.12 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.44 us    (70.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.652175354334041e-18,-2.054118593969312e-17,3.691017218428183e-18)
    sum a = (3.834823084081229e-18,9.039644033315142e-18,-6.715331415940718e-18)
    sum e = 2.592000665802303
    sum de = 1.043544591017298e-18
Info: CFL hydro = 0.006989788081000139 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006989788081000139 cfl multiplier : 0.6301382212241283        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9342e+04 |  512 |      1 | 2.647e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 671.571276795425 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 1.8601405067509977, dt = 0.006989788081000139 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1871.00 ns (0.6%)
   gen split merge   : 1167.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 1026.00 ns (0.3%)
   LB compute        : 276.97 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2000.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.950764632636549e-18,-2.06172969322016e-17,3.429385681680275e-18)
    sum a = (1.2580561592479001e-16,-7.095886378483129e-18,-3.103572086826656e-17)
    sum e = 2.592000793713433
    sum de = 5.658180087658726e-19
Info: CFL hydro = 0.008355090197894677 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008355090197894677 cfl multiplier : 0.7534254808160856        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9882e+04 |  512 |      1 | 2.575e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 977.1514639853589 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.8671302948319979, dt = 0.008355090197894677 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.70 us    (1.6%)
   patch tree reduce : 1120.00 ns (0.4%)
   gen split merge   : 713.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 947.00 ns  (0.3%)
   LB compute        : 278.86 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.2153780466236415e-18,-2.0664134466052974e-17,3.1582402708688063e-18)
    sum a = (-1.0169599537479535e-16,8.135679629983628e-17,-1.0245710529988016e-18)
    sum e = 2.5920008882440486
    sum de = -1.7279472123987727e-18
Info: CFL hydro = 0.009266090080192585 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009266090080192585 cfl multiplier : 0.8356169872107237        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0198e+04 |  512 |      1 | 2.535e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1186.5439179795612 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.8754853850298925, dt = 0.009266090080192585 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1402.00 ns (0.5%)
   gen split merge   : 1071.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 886.00 ns  (0.3%)
   LB compute        : 291.11 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.353586076031533e-18,-1.942879451072299e-17,3.343394896875018e-18)
    sum a = (-1.3203500792702272e-16,8.252773464612062e-17,1.801664286510407e-16)
    sum e = 2.5920009477376413
    sum de = -2.7172816947917955e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011226568781436908
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3887142264200634e-18,-1.9402448397931592e-17,4.094625029663068e-18)
    sum a = (4.618180837745456e-17,1.5376762363406017e-16,-6.2042168277876e-17)
    sum e = 2.592000521879723
    sum de = 2.1480755542369057e-18
Info: CFL hydro = 0.004938632964360414 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004938632964360414 cfl multiplier : 0.44520566240357456       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4685e+04 |  512 |      1 | 3.486e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 956.7762975671475 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.8847514751100851, dt = 0.004938632964360414 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.4%)
   patch tree reduce : 1538.00 ns (0.5%)
   gen split merge   : 721.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 931.00 ns  (0.3%)
   LB compute        : 297.16 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.413285279418865e-18,-1.8225655359915827e-17,2.534349683239179e-18)
    sum a = (1.4803002573726687e-16,-1.2458784004465428e-17,-8.002778127680354e-17)
    sum e = 2.592000641886583
    sum de = 6.911788849595091e-19
Info: CFL hydro = 0.0069885724064688085 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0069885724064688085 cfl multiplier : 0.6301371082690497       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9550e+04 |  512 |      1 | 2.619e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 678.8731950629954 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.8896901080744455, dt = 0.0069885724064688085 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.4%)
   patch tree reduce : 1609.00 ns (0.5%)
   gen split merge   : 745.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1314.00 ns (0.4%)
   LB compute        : 288.30 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.689608076868801e-18,-1.8664757239772455e-17,1.9993772262805186e-18)
    sum a = (7.212980213111565e-18,3.831310269042376e-17,-5.733499612581294e-17)
    sum e = 2.5920007540287977
    sum de = 9.622294280808852e-19
Info: CFL hydro = 0.00835505167443579 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00835505167443579 cfl multiplier : 0.7534247388460331         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9712e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 968.595326234588 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 1.8966786804809144, dt = 0.00835505167443579 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.75 us    (1.6%)
   patch tree reduce : 1241.00 ns (0.4%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1105.00 ns (0.4%)
   LB compute        : 281.62 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.221232738355063e-18,-1.8234437397512958e-17,1.57930309455101e-18)
    sum a = (-1.969284110781011e-16,-4.487621212134751e-17,1.1584678528964166e-16)
    sum e = 2.592000846832086
    sum de = 4.2012834183813297e-19
Info: CFL hydro = 0.00926808012504917 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00926808012504917 cfl multiplier : 0.835616492564022          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9216e+04 |  512 |      1 | 2.664e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1128.8731034442594 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.90503373215535, dt = 0.00926808012504917 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.70 us    (1.6%)
   patch tree reduce : 2.21 us    (0.8%)
   gen split merge   : 622.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 925.00 ns  (0.3%)
   LB compute        : 276.27 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1991.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4168353990040572e-18,-1.902189343538918e-17,3.3913301854260335e-18)
    sum a = (2.7353119769202295e-17,1.6111233441112871e-16,-3.5227680147964514e-17)
    sum e = 2.5920009203309364
    sum de = -1.6534083130403943e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010597999902881305
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.7077949257825475e-18,-1.8295911660692887e-17,2.737068384439656e-18)
    sum a = (8.636841242193327e-17,-3.4179690328040025e-17,-6.201874951095033e-17)
    sum e = 2.592000527977413
    sum de = -3.6253010142484055e-18
Info: CFL hydro = 0.004940482843497286 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004940482843497286 cfl multiplier : 0.44520549752134064       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4358e+04 |  512 |      1 | 3.566e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 935.6395138763961 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.9143018122803992, dt = 0.004940482843497286 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.3%)
   patch tree reduce : 1475.00 ns (0.5%)
   gen split merge   : 649.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 953.00 ns  (0.3%)
   LB compute        : 310.12 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.539161151644432e-18,-1.9112641157226216e-17,2.3082122151130147e-18)
    sum a = (-8.037320808895743e-17,1.0648897535254706e-16,1.8228582705781536e-17)
    sum e = 2.5920006379917533
    sum de = -5.55653613398821e-18
Info: CFL hydro = 0.006994382406820002 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006994382406820002 cfl multiplier : 0.6301369983475604        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9802e+04 |  512 |      1 | 2.586e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 687.8634381313782 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.9192422951238965, dt = 0.006994382406820002 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1449.00 ns (0.5%)
   gen split merge   : 640.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 929.00 ns  (0.3%)
   LB compute        : 274.94 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.78 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5819190535569803e-18,-1.806172399143602e-17,2.655102700199752e-18)
    sum a = (6.046725620212356e-17,4.2911963045455526e-17,-1.1779639763620508e-17)
    sum e = 2.592000754581358
    sum de = 1.1858461261560205e-18
Info: CFL hydro = 0.0083592604610484 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0083592604610484 cfl multiplier : 0.7534246655650403          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0055e+04 |  512 |      1 | 2.553e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 986.3078134388885 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.9262366775307165, dt = 0.0083592604610484 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.4%)
   patch tree reduce : 1452.00 ns (0.5%)
   gen split merge   : 728.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 896.00 ns  (0.3%)
   LB compute        : 273.60 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.34 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1956.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.3196102117161173e-18,-1.7880228547761945e-17,2.5123945892463474e-18)
    sum a = (-1.5451702417568213e-16,-7.770346865942912e-17,-5.4802841951973045e-17)
    sum e = 2.5920008632375633
    sum de = 1.7618285302889447e-18
Info: CFL hydro = 0.009269301501259083 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009269301501259083 cfl multiplier : 0.8356164437100269        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9715e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1158.7591439415548 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.9345959379917648, dt = 0.009269301501259083 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 1444.00 ns (0.5%)
   gen split merge   : 801.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1203.00 ns (0.4%)
   LB compute        : 290.88 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.47 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0948273537758625e-18,-1.908336769856911e-17,1.952539692429145e-18)
    sum a = (2.7259444701499547e-17,-1.0229317393140035e-16,7.791496939822672e-18)
    sum e = 2.592000961457199
    sum de = 1.07742590890747e-18
Info: CFL hydro = 0.00987873043821215 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00987873043821215 cfl multiplier : 0.8904109624733513         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9294e+04 |  512 |      1 | 2.654e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1257.4781121021792 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.9438652394930238, dt = 0.00987873043821215 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.91 us    (1.6%)
   patch tree reduce : 1365.00 ns (0.5%)
   gen split merge   : 747.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1164.00 ns (0.4%)
   LB compute        : 280.37 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.35 us    (64.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3184579256430027e-18,-2.037139987948189e-17,2.412864829812178e-18)
    sum a = (-7.287920267273762e-17,4.1919592796979545e-18,9.482112360917339e-17)
    sum e = 2.592001052531792
    sum de = -1.2366681029912785e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010924477409007335
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.684687545716601e-18,-1.9645418104785595e-17,2.734141038573945e-18)
    sum a = (-9.344088003349072e-17,3.2317898357447914e-17,4.7749402088542726e-17)
    sum e = 2.592000545057822
    sum de = -3.364414866494081e-18
Info: CFL hydro = 0.005146230573944364 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005146230573944364 cfl multiplier : 0.46347032082445044       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4746e+04 |  512 |      1 | 3.472e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1024.2705548932668 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.953743969931236, dt = 0.005146230573944364 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.3%)
   patch tree reduce : 1506.00 ns (0.5%)
   gen split merge   : 712.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 916.00 ns  (0.3%)
   LB compute        : 301.46 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1767930380157664e-18,-1.925608110464605e-17,2.8263524333438373e-18)
    sum a = (1.0234001146525173e-16,-3.2177385755893794e-17,-1.2177173332184043e-16)
    sum e = 2.5920006797806803
    sum de = 2.8663594935085523e-18
Info: CFL hydro = 0.007135200424345643 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007135200424345643 cfl multiplier : 0.6423135472163003        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9847e+04 |  512 |      1 | 2.580e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 718.1358850947123 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.9588902005051803, dt = 0.007135200424345643 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.94 us    (1.3%)
   patch tree reduce : 1640.00 ns (0.5%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 913.00 ns  (0.3%)
   LB compute        : 290.12 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2774750835230506e-18,-1.9578089149874244e-17,1.4446451847283104e-18)
    sum a = (-2.1737299460422577e-16,-1.2856903042202105e-16,-4.0982842119952065e-19)
    sum e = 2.592000823877612
    sum de = -1.3857459017080354e-18
Info: CFL hydro = 0.008466688152853447 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008466688152853447 cfl multiplier : 0.7615423648108669        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0026e+04 |  512 |      1 | 2.557e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1004.6875311494574 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.966025400929526, dt = 0.008466688152853447 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 1298.00 ns (0.4%)
   gen split merge   : 1163.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 822.00 ns  (0.3%)
   LB compute        : 286.80 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.264520152621244e-19,-2.0898322135309842e-17,1.8588646247263973e-18)
    sum a = (4.501087003117021e-17,-7.817184399794286e-17,7.754539198268074e-17)
    sum e = 2.5920009624905704
    sum de = 2.1531577519204315e-18
Info: CFL hydro = 0.00936238553099454 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00936238553099454 cfl multiplier : 0.8410282432072446         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9950e+04 |  512 |      1 | 2.566e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1187.6265736800176 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 1.9744920890823794, dt = 0.00936238553099454 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.3%)
   patch tree reduce : 1167.00 ns (0.4%)
   gen split merge   : 734.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 301.78 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.162592559674999e-19,-2.1726761015306018e-17,2.770001025428903e-18)
    sum a = (3.78915648857614e-17,8.034978932203174e-17,9.385070845469024e-17)
    sum e = 2.592001086983285
    sum de = 1.943093581001365e-18
Info: CFL hydro = 0.009969910387672504 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009969910387672504 cfl multiplier : 0.8940188288048297        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0028e+04 |  512 |      1 | 2.556e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1318.411980894326 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.983854474613374, dt = 0.009969910387672504 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.4%)
   patch tree reduce : 1382.00 ns (0.5%)
   gen split merge   : 565.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 879.00 ns  (0.3%)
   LB compute        : 285.15 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2190565939519672e-18,-2.0064028563582247e-17,3.822381864151958e-18)
    sum a = (-8.215303437530963e-17,1.8266638202035778e-17,8.051957538224297e-17)
    sum e = 2.5920011943363357
    sum de = 7.95363937471788e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011604390160458005
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.348681346260432e-19,-2.0283579503510562e-17,3.817990845353392e-18)
    sum a = (-1.862260345930622e-16,4.9062316709314045e-17,-3.313170050811554e-17)
    sum e = 2.592000559434836
    sum de = 1.5924219408380846e-18
Info: CFL hydro = 0.005190074504094543 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005190074504094543 cfl multiplier : 0.4646729429349432        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4731e+04 |  512 |      1 | 3.476e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1032.634067287912 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.9938243850010464, dt = 0.005190074504094543 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1363.00 ns (0.4%)
   gen split merge   : 648.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 963.00 ns  (0.3%)
   LB compute        : 288.69 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.135277119927092e-19,-1.9990844916939477e-17,3.0546854108692843e-18)
    sum a = (-5.302008831975513e-17,6.721186107672139e-17,1.2351057676607268e-16)
    sum e = 2.592000728519855
    sum de = 8.139986623113826e-19
Info: CFL hydro = 0.007180577889308288 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007180577889308288 cfl multiplier : 0.6431152952899621        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9779e+04 |  512 |      1 | 2.589e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 721.8029940618361 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 1.999014459505141, dt = 0.0009855404948591051 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.20 us    (1.8%)
   patch tree reduce : 1912.00 ns (0.7%)
   gen split merge   : 782.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 275.53 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.613185697500578e-19,-1.9879605774042464e-17,3.472198114966296e-18)
    sum a = (-4.1451217458465805e-17,-8.407337326321595e-17,5.604110925316875e-17)
    sum e = 2.592000558819561
    sum de = -1.6220680939919851e-18
Info: CFL hydro = 0.008508936374390746 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008508936374390746 cfl multiplier : 0.7620768635266414        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9160e+04 |  512 |      1 | 2.672e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 132.77402908883846 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 267                                                     [SPH][rank=0]
Info: time since start : 1739.354839973 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14958908707121965 max=0.15035900209409492 delta=0.0007699150228752671
Number of particle pairs: 130816
Distance min=0.145915 max=1.993868 mean=0.806647
---------------- t = 2, dt = 0.008508936374390746 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.74 us    (1.4%)
   patch tree reduce : 923.00 ns  (0.1%)
   gen split merge   : 412.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 872.00 ns  (0.1%)
   LB compute        : 676.86 us  (96.4%)
   LB move op cnt    : 0
   LB apply          : 6.33 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.11 us    (78.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.084176995020286e-19,-2.0801719721741385e-17,3.99326567906283e-18)
    sum a = (-4.0561304315289706e-17,-2.646320662602619e-17,-1.7786553480059197e-17)
    sum e = 2.5920010356818093
    sum de = 4.955142741437657e-19
Info: CFL hydro = 0.009391121285939441 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009391121285939441 cfl multiplier : 0.8413845756844275        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5291e+04 |  512 |      1 | 3.348e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 914.8263533806077 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.008508936374391, dt = 0.009391121285939441 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.2%)
   patch tree reduce : 1151.00 ns (0.3%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1377.00 ns (0.3%)
   LB compute        : 376.44 us  (95.5%)
   LB move op cnt    : 0
   LB apply          : 3.62 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0655538951187537e-18,-2.069048057884437e-17,3.584169094329736e-18)
    sum a = (6.70245109413159e-17,1.1737485983154273e-16,6.488169376761554e-17)
    sum e = 2.59200115960828
    sum de = -2.591920818598159e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010366137861461176
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.813397502442031e-19,-2.002158204852944e-17,4.0082683266245975e-18)
    sum a = (-3.077225974035258e-17,-5.43315392675936e-17,-2.879337393513204e-17)
    sum e = 2.5920005573071037
    sum de = 6.335806445462167e-19
Info: CFL hydro = 0.0049922059117320505 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0049922059117320505 cfl multiplier : 0.4471281918948091       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4333e+04 |  512 |      1 | 3.572e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 946.4232481861824 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.0179000576603303, dt = 0.0049922059117320505 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.59 us    (1.6%)
   patch tree reduce : 1093.00 ns (0.4%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1008.00 ns (0.3%)
   LB compute        : 278.78 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (64.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3626795004884063e-18,-2.1150073879760977e-17,3.3997463047899523e-18)
    sum a = (8.257457217997199e-17,-1.5971599043318464e-17,2.5713806084404212e-17)
    sum e = 2.5920007257355673
    sum de = -2.1412992906588713e-18
Info: CFL hydro = 0.007051135966554147 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007051135966554147 cfl multiplier : 0.6314187945965394        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9806e+04 |  512 |      1 | 2.585e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 695.2167016817159 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.0228922635720625, dt = 0.007051135966554147 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.5%)
   patch tree reduce : 1745.00 ns (0.6%)
   gen split merge   : 634.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 956.00 ns  (0.3%)
   LB compute        : 285.75 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.1468968056391765e-19,-2.117202897375381e-17,3.6557061089230456e-18)
    sum a = (7.353492814665685e-17,-7.93427823442272e-17,9.469378406401496e-17)
    sum e = 2.592000897200478
    sum de = 1.3264535954002343e-18
Info: CFL hydro = 0.008417825698015349 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008417825698015349 cfl multiplier : 0.7542791963976928        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9483e+04 |  512 |      1 | 2.628e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 965.9192543815694 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.0299433995386167, dt = 0.008417825698015349 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.90 us    (1.3%)
   patch tree reduce : 1337.00 ns (0.4%)
   gen split merge   : 684.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 872.00 ns  (0.3%)
   LB compute        : 292.39 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.127028158298682e-19,-2.1925820534174355e-17,4.685537236524297e-18)
    sum a = (-7.475270402679257e-17,-5.882794251732548e-17,5.5303418095009605e-17)
    sum e = 2.592001041638216
    sum de = 2.0565959959334412e-18
Info: CFL hydro = 0.009315251367583394 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009315251367583394 cfl multiplier : 0.8361861309317952        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0249e+04 |  512 |      1 | 2.529e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1198.4935749559952 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.038361225236632, dt = 0.009315251367583394 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.3%)
   patch tree reduce : 1664.00 ns (0.5%)
   gen split merge   : 772.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 883.00 ns  (0.3%)
   LB compute        : 316.92 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1475195793586579e-18,-2.241468729374807e-17,5.1103225655064336e-18)
    sum a = (-1.5128523433993734e-16,1.592476150946709e-18,-6.866382462611398e-17)
    sum e = 2.5920011435819776
    sum de = -1.4704491964334654e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011043614013260242
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4958737373782505e-18,-2.2250755925268262e-17,4.5474488432652174e-18)
    sum a = (4.6790696317522416e-17,-1.433228535852038e-17,-1.789193793122479e-17)
    sum e = 2.5920005563361896
    sum de = 1.5958100726271018e-18
Info: CFL hydro = 0.004954867267647254 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004954867267647254 cfl multiplier : 0.4453953769772651        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4879e+04 |  512 |      1 | 3.441e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 974.5535719240656 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.0476764766042157, dt = 0.004954867267647254 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.3%)
   patch tree reduce : 1062.00 ns (0.3%)
   gen split merge   : 636.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 887.00 ns  (0.3%)
   LB compute        : 290.64 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.9811903773667724e-19,-2.2410296274949503e-17,4.657590231462588e-18)
    sum a = (-3.100644740960945e-17,-2.393397979805201e-17,1.6041855344095524e-17)
    sum e = 2.5920007212929703
    sum de = 1.412850956020173e-18
Info: CFL hydro = 0.007006435063047267 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007006435063047267 cfl multiplier : 0.6302635846515101        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9650e+04 |  512 |      1 | 2.606e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 684.5857900749254 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.052631343871863, dt = 0.007006435063047267 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.3%)
   patch tree reduce : 1174.00 ns (0.4%)
   gen split merge   : 646.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 868.00 ns  (0.3%)
   LB compute        : 286.15 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.14742631799281e-19,-2.2496652977987975e-17,5.033205297856613e-18)
    sum a = (-8.440123600017557e-17,-5.3254275989012e-17,9.81012146517024e-17)
    sum e = 2.592000878206114
    sum de = -3.049318610115481e-20
Info: CFL hydro = 0.008369896218112993 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008369896218112993 cfl multiplier : 0.7535090564343401        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0624e+04 |  512 |      1 | 2.483e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1016.0234509609545 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.0596377789349103, dt = 0.008369896218112993 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 969.00 ns  (0.3%)
   gen split merge   : 661.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 761.00 ns  (0.3%)
   LB compute        : 285.17 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.823736474337867e-18,-2.3177626809998962e-17,6.019720854601174e-18)
    sum a = (1.2428339607462034e-16,1.2931843096364303e-16,7.180193939415602e-17)
    sum e = 2.592001001369233
    sum de = -1.1926223897340549e-18
Info: CFL hydro = 0.009276917146800743 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009276917146800743 cfl multiplier : 0.8356727042895601        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0403e+04 |  512 |      1 | 2.509e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1200.7112858141436 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.0680076751530234, dt = 0.009276917146800743 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.86 us    (1.3%)
   patch tree reduce : 1172.00 ns (0.4%)
   gen split merge   : 743.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 943.00 ns  (0.3%)
   LB compute        : 291.64 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.927345865710862e-20,-2.130961422944222e-17,6.550668210994481e-18)
    sum a = (2.431804757563327e-16,7.962380754733544e-18,-6.138058811222535e-17)
    sum e = 2.592001080357266
    sum de = -2.791820594150174e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.012310911677632591
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.762168949792091e-19,-2.1847148114033378e-17,5.899333755873814e-18)
    sum a = (-6.189580098459047e-17,-3.7001651742585295e-18,-1.440488353599001e-16)
    sum e = 2.592000554662975
    sum de = -1.7753810574450135e-18
Info: CFL hydro = 0.004942376874512779 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004942376874512779 cfl multiplier : 0.44522423476318673       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 8.7534e+03 |  512 |      1 | 5.849e-02 | 0.0% |   2.4% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 570.9692138772251 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.077284592299824, dt = 0.004942376874512779 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1309.00 ns (0.4%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 927.00 ns  (0.3%)
   LB compute        : 291.68 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.69421722116126e-19,-2.1813849554810915e-17,4.781087635172265e-18)
    sum a = (-1.0351094981153608e-16,-3.817259008886964e-17,-2.5760643618255583e-18)
    sum e = 2.592000703009388
    sum de = 5.827586677109586e-19
Info: CFL hydro = 0.006995279700087645 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006995279700087645 cfl multiplier : 0.6301494898421245        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9083e+04 |  512 |      1 | 2.683e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 663.1409118880949 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.0822269691743367, dt = 0.006995279700087645 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.4%)
   patch tree reduce : 1330.00 ns (0.4%)
   gen split merge   : 915.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 955.00 ns  (0.3%)
   LB compute        : 281.92 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.68 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6188222637381066e-18,-2.2143175964703387e-17,5.151396887184689e-18)
    sum a = (3.4261656012279926e-17,-3.8640965427383376e-17,3.688455790795686e-17)
    sum e = 2.592000838080572
    sum de = 2.236166980751353e-19
Info: CFL hydro = 0.008365975147973447 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008365975147973447 cfl multiplier : 0.753432993228083         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9604e+04 |  512 |      1 | 2.612e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 964.21855054117 (tsim/hr)                               [sph::Model][rank=0]
---------------- t = 2.0892222488744245, dt = 0.008365975147973447 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.4%)
   patch tree reduce : 946.00 ns  (0.3%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1106.00 ns (0.4%)
   LB compute        : 280.10 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.51 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.840584514446803e-19,-2.2480552575726564e-17,5.6000126411048785e-18)
    sum a = (5.222385024428178e-18,4.1217029789208935e-18,2.021273773356036e-16)
    sum e = 2.5920009409125533
    sum de = -2.927345865710862e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01014641583591446
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.045498725046563e-19,-2.263862925247495e-17,6.251347096225545e-18)
    sum a = (6.807835545297181e-17,-7.508056676375219e-17,-2.3629535828018077e-17)
    sum e = 2.5920005569879323
    sum de = -1.0638733817514012e-18
Info: CFL hydro = 0.004643157659228819 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004643157659228819 cfl multiplier : 0.4178109977426943        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4469e+04 |  512 |      1 | 3.538e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 851.1431011821327 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.097588224022398, dt = 0.004643157659228819 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.42 us    (1.9%)
   patch tree reduce : 944.00 ns  (0.3%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1068.00 ns (0.4%)
   LB compute        : 275.37 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.864096542738338e-19,-2.3310455128655594e-17,5.3380151861237565e-18)
    sum a = (-1.6978606021123e-18,9.072430307011103e-17,-5.264538804894414e-17)
    sum e = 2.592000674304337
    sum de = -2.066760391300493e-18
Info: CFL hydro = 0.006801044131167416 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006801044131167416 cfl multiplier : 0.6118739984951295        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9715e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 643.6371283789194 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.102231381681627, dt = 0.006801044131167416 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.4%)
   patch tree reduce : 1097.00 ns (0.4%)
   gen split merge   : 724.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 992.00 ns  (0.3%)
   LB compute        : 291.22 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.679050979479072e-19,-2.2092679248519876e-17,4.707172152063066e-18)
    sum a = (-1.2909595267784902e-16,4.8476847536171875e-17,8.908498938531295e-17)
    sum e = 2.592000797585509
    sum de = 1.4840017235895342e-18
Info: CFL hydro = 0.008223568305049861 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008223568305049861 cfl multiplier : 0.7412493323300863        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9022e+04 |  512 |      1 | 2.692e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 909.6525576075998 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.1090324258127944, dt = 0.008223568305049861 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.4%)
   patch tree reduce : 1157.00 ns (0.4%)
   gen split merge   : 748.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1051.00 ns (0.3%)
   LB compute        : 297.11 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.8793560457863733e-18,-2.2329794263642454e-17,5.996668005908701e-18)
    sum a = (3.3436144478149466e-17,3.208371068819105e-17,2.8336707980081143e-18)
    sum e = 2.592000894178354
    sum de = 1.782157321023048e-18
Info: CFL hydro = 0.009163032687291716 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009163032687291716 cfl multiplier : 0.8274995548867242        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9299e+04 |  512 |      1 | 2.653e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1115.8870844615203 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.117255994117844, dt = 0.009163032687291716 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.5%)
   patch tree reduce : 1505.00 ns (0.5%)
   gen split merge   : 730.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 986.00 ns  (0.3%)
   LB compute        : 288.55 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.49 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2470493387928273e-18,-2.180579935368021e-17,5.6117220245677224e-18)
    sum a = (-6.584991341269941e-17,1.981696057251625e-16,-2.875824578474351e-17)
    sum e = 2.592000959456454
    sum de = 1.0232158002831948e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011723131437627791
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5368565794982026e-18,-2.1240821601598015e-17,5.556102453119216e-18)
    sum a = (7.988617092054978e-17,-4.8757872739280116e-17,7.330074047739999e-17)
    sum e = 2.592000558340119
    sum de = 8.809142651444724e-20
Info: CFL hydro = 0.004893158836172238 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004893158836172238 cfl multiplier : 0.44249985162890804       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4324e+04 |  512 |      1 | 3.574e-02 | 0.0% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 922.8633660615395 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.1264190268051357, dt = 0.004893158836172238 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1683.00 ns (0.6%)
   gen split merge   : 1478.00 ns (0.5%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 285.00 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.37 us    (70.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.474136768879312e-19,-2.2224409812476865e-17,6.434306212832474e-18)
    sum a = (-7.957111532175265e-17,-2.71657696337968e-17,-1.395758508770939e-17)
    sum e = 2.5920006717300375
    sum de = 9.351243737687476e-19
Info: CFL hydro = 0.006943242491694952 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006943242491694952 cfl multiplier : 0.628333234419272         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0184e+04 |  512 |      1 | 2.537e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 694.417025075398 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 2.131312185641308, dt = 0.006943242491694952 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.4%)
   patch tree reduce : 1438.00 ns (0.5%)
   gen split merge   : 1076.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 979.00 ns  (0.3%)
   LB compute        : 289.50 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.35 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4256174366011897e-18,-2.2323939571911032e-17,6.0713153254843275e-18)
    sum a = (8.860490466333637e-17,5.86171736149943e-17,-4.3418393880223505e-17)
    sum e = 2.592000782027999
    sum de = -1.4501204056993622e-18
Info: CFL hydro = 0.008306338778378762 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008306338778378762 cfl multiplier : 0.7522221562795147        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9961e+04 |  512 |      1 | 2.565e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 974.4715206465959 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.138255428133003, dt = 0.008306338778378762 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.5%)
   patch tree reduce : 1088.00 ns (0.4%)
   gen split merge   : 632.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 927.00 ns  (0.3%)
   LB compute        : 266.34 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.561957144850638e-20,-2.1589175759617607e-17,5.711251784001892e-18)
    sum a = (-5.4940427207661456e-17,4.309053114326389e-17,3.803207748731552e-17)
    sum e = 2.5920008752607666
    sum de = -3.537209587733958e-18
Info: CFL hydro = 0.009214368225835433 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009214368225835433 cfl multiplier : 0.8348147708530099        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9306e+04 |  512 |      1 | 2.652e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1127.5230323755447 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.1465617669113817, dt = 0.009214368225835433 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.5%)
   patch tree reduce : 1539.00 ns (0.5%)
   gen split merge   : 698.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 966.00 ns  (0.3%)
   LB compute        : 265.62 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.54 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2441219929271163e-18,-2.152477415057197e-17,6.396250716578233e-18)
    sum a = (2.8500639348560954e-17,6.885117476151947e-17,-1.5425941773949957e-16)
    sum e = 2.592000950065448
    sum de = 2.710505431213761e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011904020574902141
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.284388799961739e-19,-2.1170565300820955e-17,5.482918806476444e-18)
    sum a = (5.761016663718977e-18,8.079474589361979e-18,-4.049104801451264e-17)
    sum e = 2.5920005637446835
    sum de = -1.81603863891322e-18
Info: CFL hydro = 0.0049125254248700845 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0049125254248700845 cfl multiplier : 0.44493825695100336      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4908e+04 |  512 |      1 | 3.434e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 965.8843520958732 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.155776135137217, dt = 0.0049125254248700845 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.4%)
   patch tree reduce : 1276.00 ns (0.4%)
   gen split merge   : 748.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1006.00 ns (0.3%)
   LB compute        : 277.78 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1937.00 ns (63.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1328828500301036e-18,-2.1278877097852256e-17,5.793217468241796e-18)
    sum a = (-1.0784342169278815e-16,3.725925817876785e-17,-7.832406598295983e-17)
    sum e = 2.59200067216326
    sum de = 2.995108501491206e-18
Info: CFL hydro = 0.006956619317146625 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006956619317146625 cfl multiplier : 0.6299588379673356        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8093e+04 |  512 |      1 | 2.830e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 624.9487482672579 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.160688660562087, dt = 0.006956619317146625 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.99 us    (1.7%)
   patch tree reduce : 1418.00 ns (0.5%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1038.00 ns (0.3%)
   LB compute        : 283.53 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.46 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.0754882187890012e-18,-2.1249603639195147e-17,5.1257826108597194e-18)
    sum a = (6.543203479036919e-17,1.5020797106135575e-16,-2.2915263436784627e-17)
    sum e = 2.5920007876869944
    sum de = 1.07742590890747e-18
Info: CFL hydro = 0.008323284876632956 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008323284876632956 cfl multiplier : 0.7533058919782238        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9374e+04 |  512 |      1 | 2.643e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 947.6712871214116 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.167645279879234, dt = 0.008323284876632956 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.4%)
   patch tree reduce : 1168.00 ns (0.4%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 933.00 ns  (0.3%)
   LB compute        : 293.24 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.523278874876915e-19,-1.952832427015716e-17,5.067235693545502e-18)
    sum a = (-7.84528692010511e-18,-9.682489185425247e-17,8.676653145966995e-17)
    sum e = 2.592000895715843
    sum de = -1.1384122811097797e-18
Info: CFL hydro = 0.009241639850220603 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009241639850220603 cfl multiplier : 0.8355372613188159        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9309e+04 |  512 |      1 | 2.652e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1130.0195086716656 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.1759685647558666, dt = 0.009241639850220603 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.5%)
   patch tree reduce : 1657.00 ns (0.5%)
   gen split merge   : 799.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1048.00 ns (0.3%)
   LB compute        : 288.64 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.86 us    (1.3%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.38 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4109807072726354e-18,-2.1278877097852256e-17,6.501635167743824e-18)
    sum a = (1.213092126750581e-16,1.3875033934296345e-16,-1.847740710436696e-17)
    sum e = 2.5920009929771517
    sum de = -1.2468324983583301e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011103013108961432
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.6006354148243604e-19,-2.0283579503510562e-17,5.793217468241796e-18)
    sum a = (9.800753958399966e-17,-9.164934436367567e-17,3.724754879530501e-17)
    sum e = 2.5920005709297125
    sum de = 6.844026213814747e-19
Info: CFL hydro = 0.004933370419025041 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004933370419025041 cfl multiplier : 0.44517908710627196       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4665e+04 |  512 |      1 | 3.491e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 952.9167388314632 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.1852102046060873, dt = 0.004933370419025041 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.99 us    (1.5%)
   patch tree reduce : 1402.00 ns (0.4%)
   gen split merge   : 883.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 314.14 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.566659550508944e-19,-2.1559902300960497e-17,6.358195220323992e-18)
    sum a = (-2.1467983640777176e-16,-1.0143546159274708e-16,1.6217496096038177e-17)
    sum e = 2.592000689462947
    sum de = -1.0232158002831948e-18
Info: CFL hydro = 0.006989986258144496 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006989986258144496 cfl multiplier : 0.6301193914041813        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0081e+04 |  512 |      1 | 2.550e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 696.5786989753132 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.1901435750251124, dt = 0.006989986258144496 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.4%)
   patch tree reduce : 1511.00 ns (0.5%)
   gen split merge   : 765.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1041.00 ns (0.3%)
   LB compute        : 286.92 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1995.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.7019402340511255e-18,-2.2602037429153564e-17,6.5806735061180175e-18)
    sum a = (1.0500975089478004e-16,1.621947205449753e-16,-5.973541973569585e-17)
    sum e = 2.5920008238840153
    sum de = 1.3552527156068805e-19
Info: CFL hydro = 0.008371356070242041 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008371356070242041 cfl multiplier : 0.7534129276027874        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0263e+04 |  512 |      1 | 2.527e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 995.902738267752 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 2.1971335612832568, dt = 0.008371356070242041 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1449.00 ns (0.5%)
   gen split merge   : 732.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1102.00 ns (0.4%)
   LB compute        : 283.19 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.14742631799281e-19,-2.0552895323155963e-17,5.7200338215990246e-18)
    sum a = (8.73754193997378e-17,-1.8647193164578192e-17,-6.50573345195582e-17)
    sum e = 2.5920009542804663
    sum de = 5.082197683525802e-20
Info: CFL hydro = 0.009285423869604483 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009285423869604483 cfl multiplier : 0.8356086184018583        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9718e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1160.6326084035315 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.205504917353499, dt = 0.009285423869604483 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 1470.00 ns (0.5%)
   gen split merge   : 753.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 276.43 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.400423609882907e-19,-2.1132509804566714e-17,5.152128723651117e-18)
    sum a = (-1.456647302777725e-17,9.237532613837195e-17,1.19336181561569e-16)
    sum e = 2.5920010707225414
    sum de = -5.793705359219414e-19
Info: CFL hydro = 0.009888053622413056 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009888053622413056 cfl multiplier : 0.8904057456012389        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0013e+04 |  512 |      1 | 2.558e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1306.5915496387 (tsim/hr)                               [sph::Model][rank=0]
---------------- t = 2.2147903412231034, dt = 0.009888053622413056 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.80 us    (1.6%)
   patch tree reduce : 1191.00 ns (0.4%)
   gen split merge   : 1177.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 279.64 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.3371742869103825e-19,-1.9750802555951187e-17,7.221762250708696e-18)
    sum a = (3.461293751616523e-17,-7.530304504954621e-17,-7.817696685320785e-17)
    sum e = 2.5920011711422464
    sum de = -2.580062357336599e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01065315328285071
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.639843197151716e-19,-2.058216878181307e-17,6.21475527290416e-18)
    sum a = (1.402784138848645e-16,8.257457217997199e-17,4.255775419570451e-17)
    sum e = 2.59200058606996
    sum de = -1.0842021724855044e-18
Info: CFL hydro = 0.005146755395510221 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005146755395510221 cfl multiplier : 0.4634685818670796        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4526e+04 |  512 |      1 | 3.525e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1009.9055145268314 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.224678394845516, dt = 0.005146755395510221 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.5%)
   patch tree reduce : 1348.00 ns (0.4%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 987.00 ns  (0.3%)
   LB compute        : 299.20 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.015789015401669e-18,-1.948734142803721e-17,7.069540265691731e-18)
    sum a = (-5.180231243961941e-17,-2.2880135286396098e-17,9.178985696522978e-17)
    sum e = 2.5920007418219173
    sum de = 9.715467905006825e-19
Info: CFL hydro = 0.007132792163868443 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007132792163868443 cfl multiplier : 0.6423123879113865        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9679e+04 |  512 |      1 | 2.602e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 712.1293165739128 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.2298251502410262, dt = 0.007132792163868443 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.5%)
   patch tree reduce : 1490.00 ns (0.5%)
   gen split merge   : 826.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1017.00 ns (0.4%)
   LB compute        : 271.00 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3904892862126594e-19,-1.9941080037222392e-17,7.77795796519376e-18)
    sum a = (-8.337081025544535e-18,-1.6205786712575333e-17,1.175329365082911e-16)
    sum e = 2.5920009007105183
    sum de = -7.992814648528392e-19
Info: CFL hydro = 0.008458689023563995 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008458689023563995 cfl multiplier : 0.7615415919409244        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9667e+04 |  512 |      1 | 2.603e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 986.3345346654672 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.236957942404895, dt = 0.008458689023563995 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.6%)
   patch tree reduce : 1372.00 ns (0.5%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 270.88 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.38 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.39310524521863e-19,-2.0052319180119403e-17,8.992806499463768e-18)
    sum a = (-6.814861175374886e-17,-2.1756034473963125e-17,-6.99635661904896e-18)
    sum e = 2.5920010445856847
    sum de = 9.063252535621014e-19
Info: CFL hydro = 0.00934687490977895 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00934687490977895 cfl multiplier : 0.8410277279606163         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9879e+04 |  512 |      1 | 2.576e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1182.3358333538943 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.245416631428459, dt = 0.00934687490977895 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.59 us    (1.5%)
   patch tree reduce : 1091.00 ns (0.4%)
   gen split merge   : 716.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1455.00 ns (0.5%)
   LB compute        : 281.94 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.46 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.930491337070465e-19,-2.0216250548599212e-17,8.380991213530198e-18)
    sum a = (1.0725795251964598e-17,1.365548299436803e-16,2.981209029639942e-17)
    sum e = 2.5920011612396907
    sum de = 1.0164395367051604e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01010347361826324
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.720345208458765e-20,-1.9469777352842943e-17,8.483448318830077e-18)
    sum a = (1.7236212457305555e-17,-4.3980444286439987e-17,9.71293358242864e-17)
    sum e = 2.5920005873245375
    sum de = -1.4840017235895342e-18
Info: CFL hydro = 0.004973758476651883 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004973758476651883 cfl multiplier : 0.44700924265353875       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5103e+04 |  512 |      1 | 3.390e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 992.5801998527332 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.254763506338238, dt = 0.004973758476651883 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.4%)
   patch tree reduce : 1434.00 ns (0.5%)
   gen split merge   : 690.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 999.00 ns  (0.3%)
   LB compute        : 289.12 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6319953201338055e-19,-2.0558750014887385e-17,9.51094671769459e-18)
    sum a = (-4.065497938299245e-17,-7.728193085476676e-19,-1.2827629583544998e-16)
    sum e = 2.592000748240176
    sum de = -7.995991022080595e-19
Info: CFL hydro = 0.007029261497948202 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007029261497948202 cfl multiplier : 0.6313394951023592        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0148e+04 |  512 |      1 | 2.541e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 704.6233181162074 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.25973726481489, dt = 0.007029261497948202 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.5%)
   patch tree reduce : 1612.00 ns (0.5%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 890.00 ns  (0.3%)
   LB compute        : 285.87 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1967.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.191464933721607e-19,-2.0585096127678782e-17,7.798449386253736e-18)
    sum a = (5.386316392907986e-17,-1.9114397564745644e-16,2.129936851891223e-17)
    sum e = 2.5920009126376584
    sum de = -2.574980159653073e-19
Info: CFL hydro = 0.008406697588543729 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008406697588543729 cfl multiplier : 0.7542263300682395        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0394e+04 |  512 |      1 | 2.511e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1007.9448078543164 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.2667665263128383, dt = 0.008406697588543729 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.5%)
   patch tree reduce : 1349.00 ns (0.5%)
   gen split merge   : 721.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1286.00 ns (0.4%)
   LB compute        : 280.31 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2514403575913935e-19,-2.2742550030707687e-17,8.635670303847043e-18)
    sum a = (-2.314242547596379e-16,6.86169870922626e-18,8.789063227210292e-17)
    sum e = 2.5920010527205335
    sum de = 2.3174821436877657e-18
Info: CFL hydro = 0.009334596934274093 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009334596934274093 cfl multiplier : 0.8361508867121596        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0323e+04 |  512 |      1 | 2.519e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1201.2945909614675 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.275173223901382, dt = 0.009334596934274093 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1128.00 ns (0.4%)
   gen split merge   : 911.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 895.00 ns  (0.3%)
   LB compute        : 275.48 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.2456947286069183e-18,-2.1969730722160018e-17,9.88271964263987e-18)
    sum a = (-1.9020722497042898e-16,-1.810270683355597e-17,9.14971223786587e-17)
    sum e = 2.592001154298315
    sum de = -6.708500942254059e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010007618699930871
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.1154278375827847e-18,-2.194338460936862e-17,9.800753958399966e-18)
    sum a = (5.938999292354196e-17,-4.852368507002325e-17,4.156831129309424e-17)
    sum e = 2.5920005861241644
    sum de = 1.6940658945086007e-19
Info: CFL hydro = 0.004977998468978261 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004977998468978261 cfl multiplier : 0.4453836289040532        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4731e+04 |  512 |      1 | 3.476e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 966.8735264802673 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.284507820835656, dt = 0.004977998468978261 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.3%)
   patch tree reduce : 1386.00 ns (0.4%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1094.00 ns (0.3%)
   LB compute        : 297.05 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5734484028195882e-18,-2.2307839169649624e-17,9.794899266668544e-18)
    sum a = (1.2037246199803065e-17,-2.3793467196497885e-17,5.608794678702012e-17)
    sum e = 2.592000746607043
    sum de = 1.9651164376299768e-18
Info: CFL hydro = 0.0070399919327020855 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070399919327020855 cfl multiplier : 0.6302557526027021       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0406e+04 |  512 |      1 | 2.509e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 714.2472615320705 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.2894858193046344, dt = 0.0070399919327020855 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1480.00 ns (0.5%)
   gen split merge   : 652.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 996.00 ns  (0.3%)
   LB compute        : 277.01 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.664196124656625e-18,-2.2445424425338035e-17,1.0321821522496499e-17)
    sum a = (-1.1156700563397236e-16,6.978792543854694e-18,1.0906119757292388e-16)
    sum e = 2.5920008983944265
    sum de = 8.605854744103691e-19
Info: CFL hydro = 0.008403132940512873 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008403132940512873 cfl multiplier : 0.753503835068468         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9888e+04 |  512 |      1 | 2.574e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 984.4419598561909 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.2965258112373363, dt = 0.008403132940512873 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.5%)
   patch tree reduce : 1574.00 ns (0.5%)
   gen split merge   : 826.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1049.00 ns (0.4%)
   LB compute        : 274.76 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.0634674484664172e-18,-2.2184890643289766e-17,1.144592233492947e-17)
    sum a = (1.7374383182167107e-16,-7.728193085476676e-19,3.365276807221207e-17)
    sum e = 2.5920010151195876
    sum de = -3.1509625637859973e-18
Info: CFL hydro = 0.009304335791999125 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009304335791999125 cfl multiplier : 0.8356692233789786        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9144e+04 |  512 |      1 | 2.674e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1131.1111665845947 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.304928944177849, dt = 0.009304335791999125 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.5%)
   patch tree reduce : 1667.00 ns (0.6%)
   gen split merge   : 673.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 986.00 ns  (0.3%)
   LB compute        : 274.76 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.361215827555551e-19,-2.229320244032107e-17,1.1377129707085266e-17)
    sum a = (-2.042350663589154e-16,-4.746984055836734e-17,3.4425587380759736e-18)
    sum e = 2.5920010861448586
    sum de = -8.402566836762659e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011897251169938011
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.769580575822216e-18,-2.250836236145082e-17,1.1311264425106771e-17)
    sum a = (3.011653426643335e-17,-1.3840491253080955e-17,-7.807816893024011e-17)
    sum e = 2.592000583385983
    sum de = 2.222614453595284e-18
Info: CFL hydro = 0.004951183257378112 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004951183257378112 cfl multiplier : 0.44522307445965953       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4420e+04 |  512 |      1 | 3.551e-02 | 0.0% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 943.3738115683677 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.3142332799698484, dt = 0.004951183257378112 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.5%)
   patch tree reduce : 1307.00 ns (0.4%)
   gen split merge   : 960.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 973.00 ns  (0.3%)
   LB compute        : 277.51 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1984.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.030332483364376e-19,-2.2411759947882358e-17,1.0629192838396139e-17)
    sum a = (5.784435430644663e-18,1.0728137128657167e-16,-7.049048844631756e-18)
    sum e = 2.592000725078661
    sum de = 1.802486111757151e-18
Info: CFL hydro = 0.007003413941645185 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007003413941645185 cfl multiplier : 0.6301487163064396        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9386e+04 |  512 |      1 | 2.641e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 674.8832195883365 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.3191844632272267, dt = 0.007003413941645185 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1446.00 ns (0.5%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1099.00 ns (0.4%)
   LB compute        : 276.61 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.557254739192331e-19,-2.128985464484867e-17,1.0639438548926128e-17)
    sum a = (-2.4451534547109686e-16,1.8828688608252263e-17,-4.135754239076306e-17)
    sum e = 2.5920008502545313
    sum de = 9.486769009248164e-19
Info: CFL hydro = 0.008368302293114862 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008368302293114862 cfl multiplier : 0.7534324775376264        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9605e+04 |  512 |      1 | 2.612e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 965.3988297228934 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.3261878771688718, dt = 0.008368302293114862 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.65 us    (1.6%)
   patch tree reduce : 1427.00 ns (0.5%)
   gen split merge   : 636.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 282.99 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.550870535107275e-18,-2.150208722011271e-17,1.027352031571227e-17)
    sum a = (-4.868761643850306e-17,8.00687641189235e-17,2.7212607167648172e-17)
    sum e = 2.5920009407552556
    sum de = -7.860465750519907e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010356437673819698
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.8395254897395363e-18,-2.1202034268877345e-17,1.0416228426665675e-17)
    sum a = (-1.9671764217576992e-17,-9.147370361173302e-17,-4.332471881252076e-17)
    sum e = 2.5920005856174786
    sum de = 9.622294280808852e-19
Info: CFL hydro = 0.004639526638314969 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004639526638314969 cfl multiplier : 0.4178108258458755        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4436e+04 |  512 |      1 | 3.547e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 849.4375340001421 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.3345561794619867, dt = 0.004639526638314969 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.4%)
   patch tree reduce : 1285.00 ns (0.4%)
   gen split merge   : 663.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1317.00 ns (0.4%)
   LB compute        : 287.45 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.8365981438738253e-18,-2.2381754652758823e-17,9.955903289282641e-18)
    sum a = (2.510491814433635e-17,1.0386223131542139e-16,1.5503223704804724e-17)
    sum e = 2.5920006938914395
    sum de = 1.2874900798265365e-18
Info: CFL hydro = 0.006793833646461995 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006793833646461995 cfl multiplier : 0.6118738838972503        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9890e+04 |  512 |      1 | 2.574e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 648.8565862354591 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.3391957061003015, dt = 0.006793833646461995 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.5%)
   patch tree reduce : 1454.00 ns (0.5%)
   gen split merge   : 680.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1013.00 ns (0.3%)
   LB compute        : 289.37 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (69.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.4853166399885216e-18,-2.1248871802728718e-17,1.0150571789352414e-17)
    sum a = (7.805475016331442e-17,5.1333937101105673e-17,7.981115768274095e-17)
    sum e = 2.5920008029020916
    sum de = 2.303929616531697e-19
Info: CFL hydro = 0.008228874185172999 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008228874185172999 cfl multiplier : 0.7412492559315002        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9573e+04 |  512 |      1 | 2.616e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 934.9658323466701 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.3459895397467636, dt = 0.008228874185172999 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1327.00 ns (0.5%)
   gen split merge   : 690.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 957.00 ns  (0.3%)
   LB compute        : 275.54 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.39 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.7271340607694085e-18,-2.107359696901928e-17,1.1160506113022661e-17)
    sum a = (3.2797983079424496e-17,1.2749176714343946e-16,-8.519747407564893e-17)
    sum e = 2.592000883808382
    sum de = 1.9922214919421144e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01022343269215864
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.8735013540549518e-18,-2.078415564654712e-17,1.0496730437972722e-17)
    sum a = (4.621693652784309e-17,-3.512815038853034e-19,-9.451814331207231e-17)
    sum e = 2.59200058750511
    sum de = -3.3610267347050637e-18
Info: CFL hydro = 0.004594099947569533 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004594099947569533 cfl multiplier : 0.41374975197716674       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4932e+04 |  512 |      1 | 3.429e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 863.9835395624118 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.3542184139319366, dt = 0.004594099947569533 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.4%)
   patch tree reduce : 1225.00 ns (0.4%)
   gen split merge   : 657.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1275.00 ns (0.4%)
   LB compute        : 319.65 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.38 us    (70.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4490362035268767e-18,-2.1383895630784634e-17,1.002478739668515e-17)
    sum a = (9.93424092987638e-17,2.754046990460779e-17,2.384030473034926e-17)
    sum e = 2.5920006789719463
    sum de = 1.0164395367051604e-18
Info: CFL hydro = 0.006764909465210756 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006764909465210756 cfl multiplier : 0.6091665013181111        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9753e+04 |  512 |      1 | 2.592e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 638.0722188815992 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.358812513879506, dt = 0.006764909465210756 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.5%)
   patch tree reduce : 1500.00 ns (0.5%)
   gen split merge   : 645.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1031.00 ns (0.3%)
   LB compute        : 280.20 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.167294965333304e-19,-2.1003706586475434e-17,1.0376709257478577e-17)
    sum a = (1.0355778734538746e-16,-6.027990606671807e-17,2.3559279527241016e-17)
    sum e = 2.5920007743767157
    sum de = 7.182839392716467e-19
Info: CFL hydro = 0.008215415458984576 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008215415458984576 cfl multiplier : 0.7394443342120741        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9626e+04 |  512 |      1 | 2.609e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 933.5351947079307 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.3655774233447167, dt = 0.008215415458984576 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.5%)
   patch tree reduce : 1284.00 ns (0.4%)
   gen split merge   : 648.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1337.00 ns (0.5%)
   LB compute        : 277.96 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.927345865710862e-21,-2.1841842299651775e-17,1.0588941832742616e-17)
    sum a = (2.4191586234234562e-17,6.634536670047098e-17,-4.75400968591444e-17)
    sum e = 2.592000848822154
    sum de = 1.0842021724855044e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010023975953371294
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.7177292494527945e-19,-2.1442625507215457e-17,1.0488680236842018e-17)
    sum a = (-3.9454767578051e-17,-1.4627361821784035e-16,8.346448532314809e-17)
    sum e = 2.592000589761199
    sum de = -2.3310346708438345e-18
Info: CFL hydro = 0.004594251040377446 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004594251040377446 cfl multiplier : 0.41314811140402474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.3985e+04 |  512 |      1 | 3.661e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 807.8283897070505 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.373792838803701, dt = 0.004594251040377446 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.56 us    (1.8%)
   patch tree reduce : 1587.00 ns (0.5%)
   gen split merge   : 1643.00 ns (0.5%)
   split / merge op  : 0/0
   apply split merge : 967.00 ns  (0.3%)
   LB compute        : 282.02 us  (93.7%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.108748048019088e-19,-2.3044066654875907e-17,1.118977957167977e-17)
    sum a = (4.982928132613029e-17,4.8476847536171875e-17,-4.407411935414274e-17)
    sum e = 2.5920006699439826
    sum de = 1.0028870095490916e-18
Info: CFL hydro = 0.00676921719412905 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00676921719412905 cfl multiplier : 0.6087654076026832         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9643e+04 |  512 |      1 | 2.607e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 634.5362603193234 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.3783870898440784, dt = 0.00676921719412905 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.96 us    (1.3%)
   patch tree reduce : 1296.00 ns (0.4%)
   gen split merge   : 652.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 872.00 ns  (0.3%)
   LB compute        : 280.99 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.75170511376821e-19,-2.1932407062372206e-17,1.0760923402353128e-17)
    sum a = (8.962069367873804e-18,1.4039550771949293e-17,4.796163466380676e-17)
    sum e = 2.592000758213833
    sum de = -2.710505431213761e-19
Info: CFL hydro = 0.008216845520545845 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008216845520545845 cfl multiplier : 0.7391769384017888        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9671e+04 |  512 |      1 | 2.603e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 936.281967451663 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 2.3851563070382076, dt = 0.008216845520545845 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1244.00 ns (0.4%)
   gen split merge   : 655.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 910.00 ns  (0.3%)
   LB compute        : 281.54 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.32 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.239949099622443e-19,-2.2011079482513186e-17,1.1543988421430783e-17)
    sum a = (1.626726097575526e-17,2.085441194732418e-17,-8.486961133868931e-17)
    sum e = 2.59200083312566
    sum de = 1.531435568635775e-18
Info: CFL hydro = 0.009178231426662966 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009178231426662966 cfl multiplier : 0.8261179589345259        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0127e+04 |  512 |      1 | 2.544e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1162.8325557553903 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.3933731525587536, dt = 0.009178231426662966 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.5%)
   patch tree reduce : 1103.00 ns (0.4%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 995.00 ns  (0.3%)
   LB compute        : 271.36 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1934.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.985892783025079e-19,-2.1981440105622862e-17,1.0094952217903907e-17)
    sum a = (-5.162667168767676e-17,7.32773217104743e-17,2.0280652157644853e-17)
    sum e = 2.5920008933095007
    sum de = -9.622294280808852e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011531160166765494
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.654479926480271e-19,-2.1454517849794908e-17,1.0539908789491958e-17)
    sum a = (7.078322303288864e-18,-4.355890648177763e-18,3.7470027081099036e-17)
    sum e = 2.5920005943413726
    sum de = -1.9786689647860456e-18
Info: CFL hydro = 0.004910732858764405 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004910732858764405 cfl multiplier : 0.442039319644842         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4863e+04 |  512 |      1 | 3.445e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 959.1717025816722 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.4025513839854167, dt = 0.004910732858764405 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.05 us    (1.7%)
   patch tree reduce : 1246.00 ns (0.4%)
   gen split merge   : 652.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 917.00 ns  (0.3%)
   LB compute        : 285.39 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1865.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.1076890233118206e-19,-2.1987294797354284e-17,1.088240825578013e-17)
    sum a = (3.3102427049458424e-17,-4.7856250212641173e-17,4.805530973150951e-17)
    sum e = 2.592000678678524
    sum de = 2.1955093992831465e-18
Info: CFL hydro = 0.006976774369321428 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006976774369321428 cfl multiplier : 0.6280262130965614        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0007e+04 |  512 |      1 | 2.559e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 690.8030653836795 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.407462116844181, dt = 0.006976774369321428 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1458.00 ns (0.5%)
   gen split merge   : 820.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 889.00 ns  (0.3%)
   LB compute        : 282.92 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2880321809127792e-19,-2.2556663568235046e-17,1.1170751823552649e-17)
    sum a = (-5.688418486249347e-17,5.819563581033194e-18,-6.585357259503154e-17)
    sum e = 2.5920007707581973
    sum de = 2.72405795836983e-18
Info: CFL hydro = 0.008355657148239928 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008355657148239928 cfl multiplier : 0.7520174753977077        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8638e+04 |  512 |      1 | 2.747e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 914.2841526802258 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.4144388912135026, dt = 0.008355657148239928 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.2%)
   patch tree reduce : 1235.00 ns (0.4%)
   gen split merge   : 1048.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 934.00 ns  (0.3%)
   LB compute        : 308.55 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.728193085476676e-19,-2.2383218325691677e-17,1.042427862779638e-17)
    sum a = (-1.2851048350470684e-16,-3.1632899424871575e-17,-4.391018798566293e-17)
    sum e = 2.592000859147327
    sum de = 1.4365678785432934e-18
Info: CFL hydro = 0.00927802510930097 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00927802510930097 cfl multiplier : 0.8346783169318052         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8629e+04 |  512 |      1 | 2.748e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1094.4885325399068 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.4227945483617424, dt = 0.00927802510930097 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.3%)
   patch tree reduce : 1259.00 ns (0.4%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 898.00 ns  (0.3%)
   LB compute        : 288.12 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.438479106137148e-18,-2.2804756130354042e-17,9.95004859755122e-18)
    sum a = (-7.81015876971658e-17,1.3129731676886357e-16,1.2552459072168176e-17)
    sum e = 2.5920009425718944
    sum de = 1.0842021724855044e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011053354237771684
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.1925820534174355e-18,-2.2031204985339947e-17,1.025449256758515e-17)
    sum a = (-1.3039569424222462e-16,7.916714159228455e-17,-1.1245691877714847e-16)
    sum e = 2.5920006021496005
    sum de = -5.285485590866834e-19
Info: CFL hydro = 0.0049450113430559205 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0049450113430559205 cfl multiplier : 0.4448927723106017       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4240e+04 |  512 |      1 | 3.596e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 928.9588582733455 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.4320725734710433, dt = 0.0049450113430559205 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.5%)
   patch tree reduce : 1180.00 ns (0.4%)
   gen split merge   : 677.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1001.00 ns (0.3%)
   LB compute        : 291.25 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1947.00 ns (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.927345865710862e-18,-2.2079506192124177e-17,9.133319101017889e-18)
    sum a = (-4.9741460950158966e-17,-7.893734494182625e-17,-1.592476150946709e-18)
    sum e = 2.5920006971106657
    sum de = 2.6020852139652106e-18
Info: CFL hydro = 0.007001632427552561 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007001632427552561 cfl multiplier : 0.6299285148737345        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8618e+04 |  512 |      1 | 2.750e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 647.3338515410857 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.4370175848140994, dt = 0.007001632427552561 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.27 us    (1.7%)
   patch tree reduce : 2.16 us    (0.7%)
   gen split merge   : 820.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1065.00 ns (0.4%)
   LB compute        : 283.53 us  (93.7%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.36 us    (70.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.991747474756501e-18,-2.2971614844699563e-17,9.41141695826042e-18)
    sum a = (-1.0280838680376547e-16,3.748832299275973e-18,1.6088692877946897e-17)
    sum e = 2.5920008095248797
    sum de = -9.0801931945661e-19
Info: CFL hydro = 0.00837474508095667 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00837474508095667 cfl multiplier : 0.7532856765824896         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9423e+04 |  512 |      1 | 2.636e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 956.1913708898134 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.4440192172416517, dt = 0.00837474508095667 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.3%)
   patch tree reduce : 1650.00 ns (0.5%)
   gen split merge   : 729.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 867.00 ns  (0.3%)
   LB compute        : 287.81 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.43 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.1831772421008216e-18,-2.2778410017562645e-17,9.61047647712876e-18)
    sum a = (-9.660241356845845e-17,-1.6122942824575714e-16,-3.1170378778089256e-17)
    sum e = 2.592000922852282
    sum de = 9.486769009248164e-19
Info: CFL hydro = 0.009295120850441459 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009295120850441459 cfl multiplier : 0.8355237843883264        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9535e+04 |  512 |      1 | 2.621e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1150.332257410302 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.4523939623226085, dt = 0.009295120850441459 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.4%)
   patch tree reduce : 1195.00 ns (0.4%)
   gen split merge   : 735.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1024.00 ns (0.3%)
   LB compute        : 279.95 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1940.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.775964779907271e-18,-2.4750709294585338e-17,9.197720710063529e-18)
    sum a = (4.917941054394248e-18,-3.0444397003392966e-17,-4.1053098420729125e-17)
    sum e = 2.592001031335854
    sum de = 1.6940658945086007e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011332816739573962
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.3807730880363046e-18,-2.413230748045392e-17,9.06599014610654e-18)
    sum a = (-9.138002854403027e-17,-3.818429947233248e-17,-9.503335618443743e-17)
    sum e = 2.5920006097703383
    sum de = -5.55653613398821e-19
Info: CFL hydro = 0.004958395386779219 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004958395386779219 cfl multiplier : 0.4451745947961088        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4185e+04 |  512 |      1 | 3.609e-02 | 0.0% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 927.1105339712452 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.46168908317305, dt = 0.004958395386779219 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1812.00 ns (0.6%)
   gen split merge   : 709.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1529.00 ns (0.5%)
   LB compute        : 283.38 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.64 us    (72.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.3760706823779976e-18,-2.4519448971194178e-17,8.468811589501524e-18)
    sum a = (-9.636822589920158e-17,2.183800015820303e-17,-9.625113206457314e-18)
    sum e = 2.592000727795665
    sum de = -3.6591823321385775e-19
Info: CFL hydro = 0.007018523353577191 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007018523353577191 cfl multiplier : 0.6301163965307391        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8904e+04 |  512 |      1 | 2.708e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 659.0744477636383 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.466647478559829, dt = 0.007018523353577191 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.79 us    (1.6%)
   patch tree reduce : 1833.00 ns (0.6%)
   gen split merge   : 709.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1006.00 ns (0.3%)
   LB compute        : 283.10 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1943.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.059605942021484e-18,-2.40130181364262e-17,8.556631965472849e-18)
    sum a = (9.461181837977505e-18,3.6966523592196767e-17,6.593553827927146e-17)
    sum e = 2.5920008665640917
    sum de = 9.012430558785756e-19
Info: CFL hydro = 0.00839386740596866 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00839386740596866 cfl multiplier : 0.7534109310204927         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9016e+04 |  512 |      1 | 2.692e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 938.4390152190397 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.4736660019134065, dt = 0.00839386740596866 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 1506.00 ns (0.5%)
   gen split merge   : 755.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 973.00 ns  (0.3%)
   LB compute        : 279.56 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.43 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.589766930574891e-18,-2.3752484354377934e-17,9.61047647712876e-18)
    sum a = (4.154489252616855e-17,-5.787948245683516e-17,8.072448959284273e-17)
    sum e = 2.592001002402967
    sum de = -7.047314121155779e-19
Info: CFL hydro = 0.009314979720469766 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009314979720469766 cfl multiplier : 0.8356072873469952        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8480e+04 |  512 |      1 | 2.771e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1090.6885273727924 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.482059869319375, dt = 0.009314979720469766 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (0.0%)
   patch tree reduce : 1512.00 ns (0.0%)
   gen split merge   : 709.00 ns  (0.0%)
   split / merge op  : 0/0
   apply split merge : 1473.00 ns (0.0%)
   LB compute        : 10.34 ms   (99.8%)
   LB move op cnt    : 0
   LB apply          : 6.53 us    (0.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 15.57 us   (51.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.745959484783735e-18,-2.4637274642289043e-17,1.025449256758515e-17)
    sum a = (1.16157083951407e-16,-5.542051192963804e-17,-2.1104407284255888e-16)
    sum e = 2.5920011242377745
    sum de = -1.7414997395548415e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01074948981729813
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.57763709750536e-18,-2.4699114823702183e-17,9.039644033315142e-18)
    sum a = (1.1821793544086744e-16,-9.464694653016358e-17,-4.356476117350905e-17)
    sum e = 2.5920006148752623
    sum de = -1.666960840196463e-18
Info: CFL hydro = 0.00496866769972973 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00496866769972973 cfl multiplier : 0.44520242911566504        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.0898e+04 |  512 |      1 | 4.698e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 713.7668000760714 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.491374849039845, dt = 0.00496866769972973 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1239.00 ns (0.4%)
   gen split merge   : 658.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 977.00 ns  (0.3%)
   LB compute        : 274.12 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1871.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.987045069098194e-18,-2.522713483422978e-17,9.505092025963168e-18)
    sum a = (-4.969462341630759e-17,3.922643460052555e-18,7.165557210087047e-17)
    sum e = 2.592000757988539
    sum de = -5.624298769768554e-19
Info: CFL hydro = 0.007037069099838783 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007037069099838783 cfl multiplier : 0.6301349527437767        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9266e+04 |  512 |      1 | 2.657e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 673.0930593342453 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.4963435167395747, dt = 0.003656483260425336 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1515.00 ns (0.5%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1450.00 ns (0.5%)
   LB compute        : 279.91 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.43 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1839.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.797919873900103e-18,-2.4981603699743282e-17,1.0075924469776787e-17)
    sum a = (-4.6369158512860054e-17,1.3415440633379738e-16,6.422011360196489e-17)
    sum e = 2.592000692205097
    sum de = -8.639736061993863e-19
Info: CFL hydro = 0.008418412896126031 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008418412896126031 cfl multiplier : 0.7534233018291845        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8857e+04 |  512 |      1 | 2.715e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 484.81732742170317 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 336                                                     [SPH][rank=0]
Info: time since start : 1742.164073078 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14960772570319103 max=0.1503191022208124 delta=0.000711376517621376
Number of particle pairs: 130816
Distance min=0.145249 max=1.993602 mean=0.806677
---------------- t = 2.5, dt = 0.008418412896126031 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 10.86 us   (2.1%)
   patch tree reduce : 1130.00 ns (0.2%)
   gen split merge   : 434.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 776.00 ns  (0.1%)
   LB compute        : 497.55 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 4.39 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (85.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.04473172220285e-18,-2.3621851545120585e-17,1.0646756913590405e-17)
    sum a = (-2.927345865710862e-17,-8.906157061838726e-17,1.354940329855933e-16)
    sum e = 2.592001053231679
    sum de = 1.128247885742728e-18
Info: CFL hydro = 0.009347168315931444 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009347168315931444 cfl multiplier : 0.8356155345527897        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6182e+04 |  512 |      1 | 3.164e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 957.8563445263405 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.508418412896126, dt = 0.009347168315931444 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.5%)
   patch tree reduce : 1568.00 ns (0.5%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 999.00 ns  (0.3%)
   LB compute        : 296.74 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.420346788596875e-18,-2.5378533503222015e-17,1.2142630650968655e-17)
    sum a = (-9.09584907393679e-17,-3.1451403981197503e-17,-8.95006724982439e-17)
    sum e = 2.5920011747395892
    sum de = -1.0562500852261125e-18
Info: CFL hydro = 0.009976314813366626 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009976314813366626 cfl multiplier : 0.8904103563685265        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8630e+04 |  512 |      1 | 2.748e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1224.3830815608735 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.5177655812120574, dt = 0.009976314813366626 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1254.00 ns (0.4%)
   gen split merge   : 918.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 279.97 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.38 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.33 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.513344551206668e-18,-2.5465118905156243e-17,1.0231073800659462e-17)
    sum a = (1.301146690391164e-16,-8.594687461727091e-18,1.1335854130378742e-16)
    sum e = 2.592001263737885
    sum de = -1.3611819462376606e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011352875924370552
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.507435328101773e-18,-2.54256454757483e-17,1.1188315898746915e-17)
    sum a = (-2.800884524312153e-17,7.426090992135315e-17,-6.484656561722702e-17)
    sum e = 2.5920006180667587
    sum de = 8.419507495707745e-19
Info: CFL hydro = 0.005196298214441021 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005196298214441021 cfl multiplier : 0.4634701187895088        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4414e+04 |  512 |      1 | 3.552e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1011.0998367115792 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.527741896025424, dt = 0.005196298214441021 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.5%)
   patch tree reduce : 1102.00 ns (0.4%)
   gen split merge   : 746.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1538.00 ns (0.5%)
   LB compute        : 273.49 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.587260034315867e-18,-2.4569762728261085e-17,9.964685326879774e-18)
    sum a = (1.5269036035547855e-17,-6.1825544683813406e-18,-1.6518427251033252e-16)
    sum e = 2.592000791477421
    sum de = 8.182338270476541e-19
Info: CFL hydro = 0.007197090663529262 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007197090663529262 cfl multiplier : 0.6423134125263391        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9056e+04 |  512 |      1 | 2.687e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 696.2301448679597 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.5329381942398648, dt = 0.007197090663529262 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.3%)
   patch tree reduce : 1316.00 ns (0.4%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 923.00 ns  (0.3%)
   LB compute        : 309.26 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.149621827392093e-18,-2.4687039522006125e-17,8.45417486017297e-18)
    sum a = (7.868705687030797e-17,-3.419139971150287e-17,9.589985056068784e-18)
    sum e = 2.592000950380793
    sum de = -1.3992984288641042e-18
Info: CFL hydro = 0.008527453116265902 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008527453116265902 cfl multiplier : 0.7615422750175593        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8007e+04 |  512 |      1 | 2.843e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 911.2261487191637 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.540135284903394, dt = 0.008527453116265902 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.5%)
   patch tree reduce : 1288.00 ns (0.4%)
   gen split merge   : 776.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1126.00 ns (0.4%)
   LB compute        : 277.59 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.209211968032479e-18,-2.508589039620923e-17,9.191866018332107e-18)
    sum a = (-1.433228535852038e-17,1.4334627235212949e-16,-5.351188242519456e-17)
    sum e = 2.5920010785624217
    sum de = 5.149960319306146e-19
Info: CFL hydro = 0.009412667656330592 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009412667656330592 cfl multiplier : 0.8410281833450396        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8446e+04 |  512 |      1 | 2.776e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1105.9720520149904 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.54866273801966, dt = 0.009412667656330592 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.4%)
   patch tree reduce : 1389.00 ns (0.4%)
   gen split merge   : 1149.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 957.00 ns  (0.3%)
   LB compute        : 291.80 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.72442484039759e-18,-2.296941933530028e-17,8.35171775487309e-18)
    sum a = (-3.650985763714587e-17,-2.2669366384064914e-17,-1.8969201209806384e-18)
    sum e = 2.592001164288403
    sum de = 5.827586677109586e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01132888633268652
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.771262374248964e-18,-2.3819813309289282e-17,8.732272717415501e-18)
    sum a = (1.2294852635985621e-17,-1.0479898199244886e-16,9.344088003349071e-18)
    sum e = 2.5920006154462087
    sum de = 3.211948935988307e-18
Info: CFL hydro = 0.004999483241314906 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004999483241314906 cfl multiplier : 0.4470093944483466        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4530e+04 |  512 |      1 | 3.524e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 961.6302477596167 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.5580754056759902, dt = 0.004999483241314906 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1597.00 ns (0.5%)
   gen split merge   : 700.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1017.00 ns (0.3%)
   LB compute        : 291.29 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.75 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.57 us    (71.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.528292667394963e-18,-2.4877317003277334e-17,8.7586188302069e-18)
    sum a = (3.1123541244237887e-17,-1.14213326296575e-16,-5.0186417521747015e-17)
    sum e = 2.592000769480823
    sum de = 2.2429432443293873e-18
Info: CFL hydro = 0.007058245217495969 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007058245217495969 cfl multiplier : 0.6313395962988978        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8760e+04 |  512 |      1 | 2.729e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 659.4557135848165 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.563074888917305, dt = 0.007058245217495969 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 1257.00 ns (0.4%)
   gen split merge   : 728.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1043.00 ns (0.4%)
   LB compute        : 279.07 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1930.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.36582497184801e-18,-2.5527187785465145e-17,8.378063867664487e-18)
    sum a = (1.6580486983386322e-17,-4.8312916167692066e-17,9.657899480153276e-17)
    sum e = 2.5920009101790833
    sum de = 1.917682592583736e-18
Info: CFL hydro = 0.008419833187798837 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008419833187798837 cfl multiplier : 0.7542263975325986        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9586e+04 |  512 |      1 | 2.614e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 972.0269188250028 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.570133134134801, dt = 0.008419833187798837 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.4%)
   patch tree reduce : 1288.00 ns (0.4%)
   gen split merge   : 720.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 879.00 ns  (0.3%)
   LB compute        : 272.27 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.33 us    (70.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.345333550788034e-18,-2.5785526058114127e-17,9.698296853100085e-18)
    sum a = (4.533873276812983e-17,-3.5713619561672514e-17,-1.3465790982269965e-16)
    sum e = 2.592001015419806
    sum de = 1.0842021724855044e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010517389204500564
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.2106756409653346e-18,-2.568526446221353e-17,8.7586188302069e-18)
    sum a = (-1.0557180130099652e-16,-1.140259761611695e-16,-1.0149693585592701e-16)
    sum e = 2.5920006165006826
    sum de = -5.692061405548898e-19
Info: CFL hydro = 0.004659711433847652 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004659711433847652 cfl multiplier : 0.41807546584419947       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4150e+04 |  512 |      1 | 3.618e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 837.6927264427709 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.5785529673225995, dt = 0.004659711433847652 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.5%)
   patch tree reduce : 1821.00 ns (0.6%)
   gen split merge   : 927.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 887.00 ns  (0.3%)
   LB compute        : 284.20 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.24695607742698e-18,-2.6479307028287602e-17,8.419046709784439e-18)
    sum a = (3.3020461365218523e-18,9.594668809453921e-17,-4.2668993338601526e-17)
    sum e = 2.5920007378670697
    sum de = 5.692061405548898e-19
Info: CFL hydro = 0.006815849246114533 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006815849246114533 cfl multiplier : 0.6120503105627996        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9068e+04 |  512 |      1 | 2.685e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 624.7437441164197 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.583212678756447, dt = 0.006815849246114533 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1609.00 ns (0.6%)
   gen split merge   : 796.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 785.00 ns  (0.3%)
   LB compute        : 272.31 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.94543945325876e-18,-2.547669106928163e-17,8.135094160810486e-18)
    sum a = (-5.2317525311984523e-17,6.732895491134983e-17,7.938961987807858e-17)
    sum e = 2.592000862042264
    sum de = -8.538092108323347e-19
Info: CFL hydro = 0.00824740966996927 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00824740966996927 cfl multiplier : 0.7413668737085329         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0304e+04 |  512 |      1 | 2.522e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 973.0518094851853 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.5900285280025614, dt = 0.00824740966996927 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1127.00 ns (0.4%)
   gen split merge   : 589.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 907.00 ns  (0.3%)
   LB compute        : 293.97 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.5894555437151504e-18,-2.5164928734583426e-17,9.188938672466396e-18)
    sum a = (-5.1568124770362545e-17,7.73990246893952e-18,-1.3536047283047026e-17)
    sum e = 2.592000954899564
    sum de = -4.87890977618477e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010739402578433265
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.489925784280981e-18,-2.5113700181933486e-17,8.99866119119519e-18)
    sum a = (-2.1006633932341147e-17,-5.254000359777855e-17,-6.697767340746452e-18)
    sum e = 2.5920006176635466
    sum de = 1.5856456772600502e-18
Info: CFL hydro = 0.004599922502841106 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004599922502841106 cfl multiplier : 0.41378895790284426       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5091e+04 |  512 |      1 | 3.393e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 875.109988624105 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 2.598275937672531, dt = 0.004599922502841106 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.6%)
   patch tree reduce : 1268.00 ns (0.4%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1513.00 ns (0.5%)
   LB compute        : 273.44 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1892.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.463579671489583e-18,-2.568892364454567e-17,8.884494702432465e-18)
    sum a = (3.6931395441808235e-17,-1.1318290055184475e-16,-2.0655352428455842e-17)
    sum e = 2.5920007217314156
    sum de = -5.421010862427522e-19
Info: CFL hydro = 0.00676951605126684 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00676951605126684 cfl multiplier : 0.6091926386018961         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0157e+04 |  512 |      1 | 2.540e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 651.9273363653706 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.602875860175372, dt = 0.00676951605126684 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.3%)
   patch tree reduce : 1614.00 ns (0.5%)
   gen split merge   : 714.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 816.00 ns  (0.3%)
   LB compute        : 301.53 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.1562083555899426e-18,-2.6741304483268725e-17,8.720563333952657e-18)
    sum a = (5.121684326647724e-17,5.18257312065451e-17,1.0838205333207896e-16)
    sum e = 2.5920008292128296
    sum de = 1.6940658945086007e-18
Info: CFL hydro = 0.00821261981666712 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00821261981666712 cfl multiplier : 0.7394617590679307         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0116e+04 |  512 |      1 | 2.545e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 957.4735672931049 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.6096453762266387, dt = 0.00821261981666712 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.4%)
   patch tree reduce : 1138.00 ns (0.4%)
   gen split merge   : 693.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1137.00 ns (0.4%)
   LB compute        : 285.14 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.39 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.761016663718977e-18,-2.5590857558044354e-17,1.0133007714158148e-17)
    sum a = (1.0070069778045365e-17,4.025686034525577e-17,-8.604054968497365e-17)
    sum e = 2.5920009097624366
    sum de = 6.2341624917916505e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010763516740428665
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.992276987110134e-18,-2.5687459971612815e-17,9.221139476989215e-18)
    sum a = (-4.2680702722064364e-17,3.759883029919031e-17,5.011616122096995e-18)
    sum e = 2.592000619294147
    sum de = 2.656295322589486e-18
Info: CFL hydro = 0.0045880249982695265 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0045880249982695265 cfl multiplier : 0.4131539196893102       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.3914e+04 |  512 |      1 | 3.680e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 803.4600520680616 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.617857996043306, dt = 0.0045880249982695265 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.4%)
   patch tree reduce : 1505.00 ns (0.5%)
   gen split merge   : 738.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1089.00 ns (0.3%)
   LB compute        : 303.80 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 4.04 us    (1.3%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1945.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.194263851844184e-18,-2.5548411042991546e-17,9.685123796704386e-18)
    sum a = (-1.6408359046482523e-16,-6.455383103065593e-17,5.3441626124417494e-17)
    sum e = 2.5920007091316783
    sum de = -2.1412992906588713e-18
Info: CFL hydro = 0.006760074777963602 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006760074777963602 cfl multiplier : 0.6087692797928734        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9708e+04 |  512 |      1 | 2.598e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 635.764980012177 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 2.6224460210415756, dt = 0.006760074777963602 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.5%)
   patch tree reduce : 1290.00 ns (0.4%)
   gen split merge   : 692.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 899.00 ns  (0.3%)
   LB compute        : 271.52 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1945.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.447167882368433e-18,-2.5977267212318187e-17,1.0107393437833178e-17)
    sum a = (1.301146690391164e-16,-1.0107539805126464e-16,-7.868705687030796e-18)
    sum e = 2.592000803422942
    sum de = 3.333921680392926e-18
Info: CFL hydro = 0.008209657042603598 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008209657042603598 cfl multiplier : 0.7391795198619157        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0190e+04 |  512 |      1 | 2.536e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 959.6475432379397 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.6292060958195393, dt = 0.008209657042603598 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.4%)
   patch tree reduce : 1541.00 ns (0.5%)
   gen split merge   : 654.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 842.00 ns  (0.3%)
   LB compute        : 275.39 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1843.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.728815859196157e-18,-2.6974028479592736e-17,9.851250674583478e-18)
    sum a = (6.276229536084088e-17,-1.8026595841047487e-17,4.458933222650785e-17)
    sum e = 2.5920008771022
    sum de = 1.748276003132876e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010468918551378133
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.015695754035821e-18,-2.6878889738957133e-17,1.0070069778045365e-17)
    sum a = (1.8017813803450354e-16,1.0644415036897836e-16,-3.3582511771435005e-17)
    sum e = 2.592000621328081
    sum de = -8.944667923005412e-19
Info: CFL hydro = 0.004591080258639696 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004591080258639696 cfl multiplier : 0.41305983995397194       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4670e+04 |  512 |      1 | 3.490e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 846.7977154924743 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.637415752862143, dt = 0.004591080258639696 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.3%)
   patch tree reduce : 1494.00 ns (0.5%)
   gen split merge   : 650.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1670.00 ns (0.5%)
   LB compute        : 303.04 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1994.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.815483949094368e-18,-2.5833827264898358e-17,9.679269104972964e-18)
    sum a = (-1.3849566025264658e-16,-1.8769556221764904e-16,-2.3793467196497885e-17)
    sum e = 2.592000700552315
    sum de = 1.1384122811097797e-18
Info: CFL hydro = 0.006767545709287379 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006767545709287379 cfl multiplier : 0.6087065599693147        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9742e+04 |  512 |      1 | 2.593e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 637.2885123771956 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.642006833120783, dt = 0.006767545709287379 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.4%)
   patch tree reduce : 1802.00 ns (0.6%)
   gen split merge   : 688.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1039.00 ns (0.3%)
   LB compute        : 295.06 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.244028731561269e-18,-2.765902741216908e-17,9.36146911942673e-18)
    sum a = (-1.956930711227711e-18,-1.8230924582474107e-16,-4.1217029789208935e-18)
    sum e = 2.5920007876426783
    sum de = -8.402566836762659e-19
Info: CFL hydro = 0.008211417290026694 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008211417290026694 cfl multiplier : 0.7391377066462098        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9300e+04 |  512 |      1 | 2.653e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 918.3618836078717 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.6487743788300704, dt = 0.008211417290026694 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.75 us    (1.3%)
   patch tree reduce : 1523.00 ns (0.5%)
   gen split merge   : 750.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 883.00 ns  (0.3%)
   LB compute        : 272.03 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1948.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.769798701316109e-18,-2.928809538643717e-17,9.420198995857553e-18)
    sum a = (1.2937112318922584e-16,4.0406154984407026e-17,-3.3535674237583636e-17)
    sum e = 2.5920008605144504
    sum de = -2.168404344971009e-18
Info: CFL hydro = 0.009171816229534634 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009171816229534634 cfl multiplier : 0.8260918044308067        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0225e+04 |  512 |      1 | 2.532e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1167.7261626281716 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.656985796120097, dt = 0.009171816229534634 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.6%)
   patch tree reduce : 1144.00 ns (0.4%)
   gen split merge   : 775.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1295.00 ns (0.4%)
   LB compute        : 272.45 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.61 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1900.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.948989572843953e-18,-2.80556827769729e-17,8.993538335930196e-18)
    sum a = (-1.4730404396257058e-17,-2.4937327593524405e-18,-1.16157083951407e-17)
    sum e = 2.592000917358897
    sum de = 9.215718466126788e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011855477582184092
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.666189309943114e-18,-2.807324685216717e-17,9.130391755152178e-18)
    sum a = (-5.784435430644663e-17,-6.605190027743346e-17,3.7516864614950405e-17)
    sum e = 2.592000625006879
    sum de = 1.3823577699190182e-18
Info: CFL hydro = 0.00490729950976211 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00490729950976211 cfl multiplier : 0.44203060147693557        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4679e+04 |  512 |      1 | 3.488e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 946.6342545141624 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.6661576123496316, dt = 0.00490729950976211 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.2%)
   patch tree reduce : 1222.00 ns (0.4%)
   gen split merge   : 718.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1641.00 ns (0.5%)
   LB compute        : 314.37 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.313132746265215e-18,-2.8906076750961904e-17,9.455327146246083e-18)
    sum a = (-5.257513174816708e-18,1.5160724238516553e-16,-1.199040866595169e-17)
    sum e = 2.5920007075987463
    sum de = 8.944667923005412e-19
Info: CFL hydro = 0.006969661547468815 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006969661547468815 cfl multiplier : 0.6280204009846236        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9902e+04 |  512 |      1 | 2.573e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 686.702877764638 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 2.6710649118593937, dt = 0.006969661547468815 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1247.00 ns (0.4%)
   gen split merge   : 610.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1275.00 ns (0.4%)
   LB compute        : 278.81 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.52 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.33 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.108218535665454e-18,-2.7215534513513884e-17,9.191866018332107e-18)
    sum a = (-3.682601099064264e-17,-1.754797479200376e-16,-7.170826432645327e-17)
    sum e = 2.59200079543406
    sum de = -1.1384122811097797e-18
Info: CFL hydro = 0.00833837514249855 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00833837514249855 cfl multiplier : 0.7520136006564156         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0008e+04 |  512 |      1 | 2.559e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 980.517063450598 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 2.6780345734068627, dt = 0.00833837514249855 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.90 us    (1.3%)
   patch tree reduce : 951.00 ns  (0.3%)
   gen split merge   : 591.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 770.00 ns  (0.3%)
   LB compute        : 279.21 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.69 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1945.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.520974302730685e-18,-2.99013743453036e-17,8.364890811268788e-18)
    sum a = (1.7989125813966388e-16,-4.043835578892985e-17,1.2224596335208559e-17)
    sum e = 2.592000876793749
    sum de = -2.4665599424045226e-18
Info: CFL hydro = 0.009248684915245798 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009248684915245798 cfl multiplier : 0.8346757337709437        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9256e+04 |  512 |      1 | 2.659e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1128.9802300822482 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.6863729485493613, dt = 0.009248684915245798 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.92 us    (1.3%)
   patch tree reduce : 1229.00 ns (0.4%)
   gen split merge   : 641.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 931.00 ns  (0.3%)
   LB compute        : 278.68 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1953.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.924418519845151e-18,-2.973890664975665e-17,8.972315078403791e-18)
    sum a = (-2.1076890233118208e-18,-3.9847031924056253e-17,4.978829848401034e-17)
    sum e = 2.592000949966872
    sum de = -7.589415207398531e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011112987590475278
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.6650370238699994e-18,-2.971548788283096e-17,8.99866119119519e-18)
    sum a = (6.437819027871328e-17,3.1392857063883284e-17,-8.936601458842119e-17)
    sum e = 2.5920006312680277
    sum de = 2.439454888092385e-19
Info: CFL hydro = 0.004929465447922303 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004929465447922303 cfl multiplier : 0.4448919112569813        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4743e+04 |  512 |      1 | 3.473e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 958.7375189074479 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.695621633464607, dt = 0.004929465447922303 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1244.00 ns (0.4%)
   gen split merge   : 649.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 970.00 ns  (0.3%)
   LB compute        : 302.03 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.3459563245075153e-18,-2.892656817202188e-17,8.041419093107738e-18)
    sum a = (-1.5252642898699875e-16,-1.213092126750581e-16,-6.847647449070848e-17)
    sum e = 2.592000720305683
    sum de = -1.2197274440461925e-19
Info: CFL hydro = 0.006979742702019356 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006979742702019356 cfl multiplier : 0.6299279408379875        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0084e+04 |  512 |      1 | 2.549e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 696.1004151958979 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.700551098912529, dt = 0.006979742702019356 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.4%)
   patch tree reduce : 1175.00 ns (0.4%)
   gen split merge   : 673.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1430.00 ns (0.5%)
   LB compute        : 270.79 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1892.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.7247362272573315e-18,-3.031413011236883e-17,7.602317213251109e-18)
    sum a = (9.262122319109167e-17,4.202497724814514e-17,1.4219875277277082e-16)
    sum e = 2.5920008220746555
    sum de = -1.4907779871675686e-19
Info: CFL hydro = 0.008348832816288 sink sink = inf                                   [SPH][rank=0]
Info: cfl dt = 0.008348832816288 cfl multiplier : 0.7532852938919916           [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8877e+04 |  512 |      1 | 2.712e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 926.4242667535736 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.7075308416145485, dt = 0.008348832816288 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.76 us    (1.2%)
   patch tree reduce : 1078.00 ns (0.3%)
   gen split merge   : 670.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1010.00 ns (0.3%)
   LB compute        : 309.19 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.094204580056381e-18,-2.935688801428138e-17,9.513874063560301e-18)
    sum a = (-8.887422048298177e-17,-1.928535456330316e-17,-7.36286032143596e-17)
    sum e = 2.5920009215604294
    sum de = 1.7076184216646695e-18
Info: CFL hydro = 0.009266799557718816 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009266799557718816 cfl multiplier : 0.8355235292613278        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9279e+04 |  512 |      1 | 2.656e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1131.7226612694649 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.7158796744308367, dt = 0.009266799557718816 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.0%)
   patch tree reduce : 1147.00 ns (0.3%)
   gen split merge   : 678.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1363.00 ns (0.3%)
   LB compute        : 398.81 us  (96.1%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1930.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.75400968591444e-18,-2.9864782521982215e-17,7.807231423850869e-18)
    sum a = (1.9636636067188463e-16,-4.1989849097756605e-17,-1.4587549918010367e-16)
    sum e = 2.592001013462547
    sum de = 6.776263578034403e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011559882187747457
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.43084935461313e-18,-3.0002367777670626e-17,7.567189062862578e-18)
    sum a = (-1.0927196647525506e-16,-2.5901156219809705e-17,7.30899715750688e-17)
    sum e = 2.5920006372539257
    sum de = 2.4665599424045226e-18
Info: CFL hydro = 0.004944672156413661 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004944672156413661 cfl multiplier : 0.445174509753776         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4949e+04 |  512 |      1 | 3.425e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 974.0168215719834 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.7251464739885556, dt = 0.004944672156413661 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.5%)
   patch tree reduce : 1293.00 ns (0.4%)
   gen split merge   : 618.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1303.00 ns (0.4%)
   LB compute        : 276.11 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1883.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.53561103205924e-18,-2.9885273943042187e-17,8.957678349075238e-18)
    sum a = (-9.730497657622905e-17,-1.9628439498764472e-16,2.817277661160134e-17)
    sum e = 2.5920007427231164
    sum de = 4.743384504624082e-19
Info: CFL hydro = 0.007004510822447835 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007004510822447835 cfl multiplier : 0.6301163398358507        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8933e+04 |  512 |      1 | 2.704e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 658.2354689411911 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.7300911461449693, dt = 0.007004510822447835 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.97 us    (1.6%)
   patch tree reduce : 1284.00 ns (0.4%)
   gen split merge   : 855.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 921.00 ns  (0.3%)
   LB compute        : 290.29 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.175236103717063e-18,-3.1468968056391766e-17,9.06599014610654e-18)
    sum a = (-3.477686888464504e-17,1.899261997673207e-17,1.7681169028893605e-17)
    sum e = 2.5920008636382126
    sum de = -1.7618285302889447e-19
Info: CFL hydro = 0.008380297559753317 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008380297559753317 cfl multiplier : 0.7534108932239004        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0028e+04 |  512 |      1 | 2.556e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 986.3921328780051 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.737095656967417, dt = 0.008380297559753317 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.94 us    (1.2%)
   patch tree reduce : 1249.00 ns (0.4%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 889.00 ns  (0.3%)
   LB compute        : 316.43 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.32 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.015695754035821e-18,-3.038438641314589e-17,9.098190950629359e-18)
    sum a = (-1.6304145533663216e-16,-1.2552459072168176e-17,-1.1147333056626963e-17)
    sum e = 2.592000979468926
    sum de = 7.995991022080595e-19
Info: CFL hydro = 0.009300039403613344 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009300039403613344 cfl multiplier : 0.8356072621492668        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9667e+04 |  512 |      1 | 2.603e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1158.8849537573358 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.74547595452717, dt = 0.009300039403613344 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.4%)
   patch tree reduce : 1141.00 ns (0.4%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1121.00 ns (0.4%)
   LB compute        : 278.54 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.088256626959112e-18,-3.0786896469681136e-17,9.007443228792322e-18)
    sum a = (5.547905884695226e-17,-4.742300302451596e-17,2.2200991045551177e-17)
    sum e = 2.5920010807566367
    sum de = -2.439454888092385e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011435827271537342
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.113450453677395e-18,-3.103718454119941e-17,9.191866018332107e-18)
    sum a = (3.3020461365218523e-17,-5.198966257502491e-18,1.1084102385927607e-16)
    sum e = 2.5920006413623313
    sum de = 2.981555974335137e-19
Info: CFL hydro = 0.0049612953542093954 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0049612953542093954 cfl multiplier : 0.44520242071642224      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4729e+04 |  512 |      1 | 3.476e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 963.142877613281 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 2.7547759939307834, dt = 0.0049612953542093954 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1422.00 ns (0.5%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 984.00 ns  (0.3%)
   LB compute        : 286.50 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1893.00 ns (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.142723912334503e-18,-3.104450290586369e-17,1.0105197928433895e-17)
    sum a = (1.4144935223114884e-16,-3.0210209334136094e-17,-9.814805218555378e-17)
    sum e = 2.5920007648564356
    sum de = -2.7376104855258987e-18
Info: CFL hydro = 0.00702709303109557 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00702709303109557 cfl multiplier : 0.6301349471442815         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9274e+04 |  512 |      1 | 2.656e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 672.358511251529 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 2.7597372892849927, dt = 0.00702709303109557 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.84 us    (1.7%)
   patch tree reduce : 1434.00 ns (0.5%)
   gen split merge   : 1016.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1037.00 ns (0.4%)
   LB compute        : 276.38 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1952.00 ns (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.8327366374288924e-18,-3.112573675363717e-17,8.872785318969623e-18)
    sum a = (-4.8617360137725995e-17,-5.405051406448536e-17,-1.5354514534826613e-16)
    sum e = 2.5920008995782764
    sum de = -2.608861477543245e-18
Info: CFL hydro = 0.00841218034363555 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00841218034363555 cfl multiplier : 0.7534232980961878         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9953e+04 |  512 |      1 | 2.566e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 985.8562956095639 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.7667643823160883, dt = 0.00841218034363555 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.77 us    (1.6%)
   patch tree reduce : 1168.00 ns (0.4%)
   gen split merge   : 1106.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 987.00 ns  (0.3%)
   LB compute        : 283.68 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.44 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.43 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.879262784420525e-18,-3.179280569278603e-17,7.36812954399424e-18)
    sum a = (4.6931208919076537e-17,-1.4072337045645255e-16,-6.666737474569917e-17)
    sum e = 2.5920010220289496
    sum de = -9.147955830346444e-19
Info: CFL hydro = 0.009335190054677525 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009335190054677525 cfl multiplier : 0.8356155320641253        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9581e+04 |  512 |      1 | 2.615e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1158.1567271456888 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.775176562659724, dt = 0.009335190054677525 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.2%)
   patch tree reduce : 1337.00 ns (0.4%)
   gen split merge   : 622.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 999.00 ns  (0.3%)
   LB compute        : 317.87 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1986.00 ns (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.843714184425308e-18,-3.336881552323812e-17,7.171997370991612e-18)
    sum a = (-1.803245053277891e-17,-1.4191772756966257e-17,1.1386863132088752e-16)
    sum e = 2.5920011197865676
    sum de = -1.5246593050577406e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010805906201732062
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.274399944918019e-18,-3.27584639102374e-17,7.991654213390653e-18)
    sum a = (-1.422455903066222e-16,-2.611192512214089e-17,8.466176978222383e-17)
    sum e = 2.5920006428563873
    sum de = -2.541098841762901e-18
Info: CFL hydro = 0.004978946825317229 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004978946825317229 cfl multiplier : 0.4452051773547085        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4639e+04 |  512 |      1 | 3.498e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 960.8512740480712 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.784511752714401, dt = 0.004978946825317229 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1301.00 ns (0.4%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1054.00 ns (0.4%)
   LB compute        : 280.40 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.36 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.62637633708492e-18,-3.311248980087181e-17,8.378063867664487e-18)
    sum a = (-1.0126274818667014e-16,-7.056074474709462e-17,5.971785566050158e-19)
    sum e = 2.5920007772590368
    sum de = -2.270048298641525e-19
Info: CFL hydro = 0.0070498013528677884 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070498013528677884 cfl multiplier : 0.6301367849031391       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9946e+04 |  512 |      1 | 2.567e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 698.2648169724068 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.7894906995397184, dt = 0.0070498013528677884 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.5%)
   patch tree reduce : 1944.00 ns (0.6%)
   gen split merge   : 758.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 287.09 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.162355069184917e-18,-3.3492953283855917e-17,8.102893356287666e-18)
    sum a = (-8.112260863057941e-17,-3.1638754116602993e-17,-9.2709043567063e-17)
    sum e = 2.5920009143891116
    sum de = -4.04373529019203e-18
Info: CFL hydro = 0.00843274960545464 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00843274960545464 cfl multiplier : 0.7534245232687594         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9811e+04 |  512 |      1 | 2.584e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 982.0314473409313 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.7965405008925863, dt = 0.00843274960545464 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.6%)
   patch tree reduce : 1228.00 ns (0.4%)
   gen split merge   : 744.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1355.00 ns (0.5%)
   LB compute        : 270.69 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.31 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.929868563350985e-18,-3.352359893588758e-17,7.049048844631756e-18)
    sum a = (5.292641325205239e-18,-1.1458802656738597e-16,-3.191977931971124e-17)
    sum e = 2.5920010304457066
    sum de = -1.6328677640694775e-18
Info: CFL hydro = 0.009360120396316781 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009360120396316781 cfl multiplier : 0.8356163488458396        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8511e+04 |  512 |      1 | 2.766e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1097.5617575651843 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.804973250498041, dt = 0.009360120396316781 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.6%)
   patch tree reduce : 1391.00 ns (0.5%)
   gen split merge   : 793.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 915.00 ns  (0.3%)
   LB compute        : 280.75 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.423437728583005e-18,-3.519474750697526e-17,6.975865197988983e-18)
    sum a = (-8.196568423990413e-19,8.086500219439685e-17,-8.430756093247283e-18)
    sum e = 2.5920011145494803
    sum de = -2.947674656444965e-19
Info: CFL hydro = 0.009976353582242052 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009976353582242052 cfl multiplier : 0.8904108992305598        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9654e+04 |  512 |      1 | 2.605e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1293.4873552351116 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.814333370894358, dt = 0.009976353582242052 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.82 us    (1.7%)
   patch tree reduce : 1329.00 ns (0.5%)
   gen split merge   : 962.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 839.00 ns  (0.3%)
   LB compute        : 274.52 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.423437728583005e-18,-3.346395426387372e-17,7.110523107811684e-18)
    sum a = (4.259873703782446e-17,-2.4402355136565746e-17,-1.899261997673207e-17)
    sum e = 2.592001166349068
    sum de = -4.0657581468206416e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011171448809434985
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.363427138335932e-18,-3.3856218609878976e-17,7.049048844631756e-18)
    sum a = (-9.159079744636144e-17,-3.292678629751577e-17,2.510491814433635e-17)
    sum e = 2.5920006419527652
    sum de = -2.392021043046144e-18
Info: CFL hydro = 0.005187120377092958 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005187120377092958 cfl multiplier : 0.46347029974352          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4835e+04 |  512 |      1 | 3.451e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1040.597404870731 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.8243097244766, dt = 0.005187120377092958 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1706.00 ns (0.6%)
   gen split merge   : 996.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 924.00 ns  (0.3%)
   LB compute        : 290.22 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1960.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.415807977058988e-18,-3.412919361185651e-17,7.283236513888625e-18)
    sum a = (-1.8128467477174226e-16,-1.3102800094921818e-16,-5.346504489134318e-17)
    sum e = 2.592000782800289
    sum de = 1.2739375526704677e-18
Info: CFL hydro = 0.007184722514269574 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007184722514269574 cfl multiplier : 0.6423135331623467        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9939e+04 |  512 |      1 | 2.568e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 727.2140960308553 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.829496844853693, dt = 0.007184722514269574 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.88 us    (1.3%)
   patch tree reduce : 1236.00 ns (0.4%)
   gen split merge   : 709.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 989.00 ns  (0.3%)
   LB compute        : 295.12 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.35 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0948273537758624e-17,-3.5368192749518634e-17,6.762168949792091e-18)
    sum a = (-1.7189374923454183e-17,1.6163632932109094e-16,2.053591671713484e-16)
    sum e = 2.5920009037280063
    sum de = 1.2197274440461925e-18
Info: CFL hydro = 0.008513548543531101 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008513548543531101 cfl multiplier : 0.7615423554415646        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9607e+04 |  512 |      1 | 2.611e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 990.5077101963532 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.8366815673679624, dt = 0.008513548543531101 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.5%)
   patch tree reduce : 1343.00 ns (0.5%)
   gen split merge   : 939.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1138.00 ns (0.4%)
   LB compute        : 275.80 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0528199406029114e-17,-3.2953132410307176e-17,9.276759048437722e-18)
    sum a = (4.472984482806197e-18,-9.344088003349072e-17,7.789081879483461e-17)
    sum e = 2.592000996664814
    sum de = 5.5429836068321414e-18
Info: CFL hydro = 0.00939857533715767 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00939857533715767 cfl multiplier : 0.841028236961043          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9671e+04 |  512 |      1 | 2.603e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1177.5343119634763 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.8451951159114937, dt = 0.00939857533715767 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.5%)
   patch tree reduce : 1394.00 ns (0.5%)
   gen split merge   : 741.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1077.00 ns (0.4%)
   LB compute        : 290.31 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.030572112023509e-17,-3.501398389976762e-17,9.531438138754566e-18)
    sum a = (1.0154377338977838e-16,9.753916424548592e-17,-1.6051222850865798e-16)
    sum e = 2.5920010562107496
    sum de = 1.2197274440461925e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011988722830935637
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.885646988505581e-18,-3.403185936182163e-17,8.539067890278584e-18)
    sum a = (3.53857568247129e-17,6.503391575263251e-17,-4.7212234122184784e-17)
    sum e = 2.592000641700618
    sum de = 1.3145951341386741e-18
Info: CFL hydro = 0.004996061895432844 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004996061895432844 cfl multiplier : 0.44700941232034763       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4964e+04 |  512 |      1 | 3.421e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 988.8951695456077 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.854593691248651, dt = 0.004996061895432844 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.84 us    (1.7%)
   patch tree reduce : 1312.00 ns (0.5%)
   gen split merge   : 710.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1333.00 ns (0.5%)
   LB compute        : 265.19 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 2.64 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0046651011119678e-17,-3.3942575312917444e-17,8.705926604624104e-18)
    sum a = (1.1250375631099985e-16,9.945950313339224e-17,1.690834972034594e-17)
    sum e = 2.592000758138889
    sum de = 5.421010862427522e-20
Info: CFL hydro = 0.007056893820603351 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007056893820603351 cfl multiplier : 0.631339608213565         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0165e+04 |  512 |      1 | 2.539e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 708.3782732957167 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.859589753144084, dt = 0.007056893820603351 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.79 us    (1.7%)
   patch tree reduce : 1250.00 ns (0.4%)
   gen split merge   : 749.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1319.00 ns (0.5%)
   LB compute        : 265.13 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.69 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.130391755152178e-18,-3.320049313595974e-17,9.03086199571801e-18)
    sum a = (-9.765625808011436e-17,-6.323067069935462e-19,3.999925390907322e-17)
    sum e = 2.592000864465362
    sum de = 2.642742795433417e-18
Info: CFL hydro = 0.008418430980225596 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008418430980225596 cfl multiplier : 0.75422640547571          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9681e+04 |  512 |      1 | 2.602e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 976.5292182164293 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.8666466469646874, dt = 0.008418430980225596 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.5%)
   patch tree reduce : 1373.00 ns (0.5%)
   gen split merge   : 734.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1101.00 ns (0.4%)
   LB compute        : 285.36 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0550154500021946e-17,-3.326196739913967e-17,9.404098593596144e-18)
    sum a = (4.4401982091102355e-17,-9.385070845469024e-17,-4.435514455725098e-17)
    sum e = 2.5920009462172153
    sum de = 4.0657581468206416e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010288873664595334
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.008763385323963e-17,-3.3926474910656033e-17,9.12014604462219e-18)
    sum a = (2.014013955609073e-18,3.587755093015232e-17,-4.9366760679347974e-17)
    sum e = 2.592000643753401
    sum de = 3.7947076036992655e-19
Info: CFL hydro = 0.0046595844127505625 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0046595844127505625 cfl multiplier : 0.4180754684919033       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4385e+04 |  512 |      1 | 3.559e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 851.4959876761855 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.875065077944913, dt = 0.0046595844127505625 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1442.00 ns (0.5%)
   gen split merge   : 679.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1027.00 ns (0.3%)
   LB compute        : 278.45 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.55 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0064215086313943e-17,-3.308486297426416e-17,8.890349394163887e-18)
    sum a = (6.750459566329248e-17,8.342935717275957e-17,7.68603930501044e-17)
    sum e = 2.5920007357034542
    sum de = 5.014435047745458e-19
Info: CFL hydro = 0.006816168463497932 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006816168463497932 cfl multiplier : 0.6120503123279355        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9564e+04 |  512 |      1 | 2.617e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 640.9844423565427 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.8797246623576633, dt = 0.006816168463497932 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.5%)
   patch tree reduce : 2.17 us    (0.7%)
   gen split merge   : 794.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 891.00 ns  (0.3%)
   LB compute        : 275.95 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1965.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.478745913171771e-18,-3.25023211469877e-17,9.629504225255881e-18)
    sum a = (3.0327303168764527e-17,4.5127963865798645e-17,5.98583682620557e-17)
    sum e = 2.5920008340334286
    sum de = 2.0328790734103208e-19
Info: CFL hydro = 0.008248579824914603 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008248579824914603 cfl multiplier : 0.7413668748852903        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9718e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 945.0115386714374 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.8865408308211613, dt = 0.008248579824914603 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1623.00 ns (0.6%)
   gen split merge   : 776.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 900.00 ns  (0.3%)
   LB compute        : 275.05 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.76 us    (70.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.303105161229119e-18,-3.2118838838579574e-17,1.0100806909635329e-17)
    sum a = (6.89916873630736e-17,-3.5022765937364755e-17,4.248164320319603e-17)
    sum e = 2.592000914298643
    sum de = -6.505213034913027e-19
Info: CFL hydro = 0.009200305552142012 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009200305552142012 cfl multiplier : 0.8275779165901934        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9628e+04 |  512 |      1 | 2.609e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1138.3762154523865 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.894789410646076, dt = 0.009200305552142012 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 16.70 us   (5.5%)
   patch tree reduce : 1336.00 ns (0.4%)
   gen split merge   : 790.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 895.00 ns  (0.3%)
   LB compute        : 272.99 us  (90.5%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.503939739890054e-18,-3.290922222232151e-17,1.055527735528694e-17)
    sum a = (1.135985836647757e-16,1.44727979600745e-17,7.198928952956152e-17)
    sum e = 2.5920009720812365
    sum de = -6.776263578034403e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.012287528910320695
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.49223035642721e-18,-3.258135948536189e-17,1.0654075278254681e-17)
    sum a = (1.7534801735608062e-17,-2.0063443094409107e-16,6.318383316550325e-17)
    sum e = 2.5920006455721696
    sum de = -2.8189256484623115e-18
Info: CFL hydro = 0.00491818676371307 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00491818676371307 cfl multiplier : 0.4425259721967311         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4455e+04 |  512 |      1 | 3.542e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 935.0861698378334 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.903989716198218, dt = 0.00491818676371307 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.5%)
   patch tree reduce : 1482.00 ns (0.5%)
   gen split merge   : 774.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1036.00 ns (0.3%)
   LB compute        : 288.03 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1964.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.869857973103912e-18,-3.45514632529853e-17,1.0920829670267584e-17)
    sum a = (1.3354551839372951e-17,-2.6539317618534676e-17,-5.025667382252408e-17)
    sum e = 2.592000737996922
    sum de = -9.486769009248164e-20
Info: CFL hydro = 0.006982487641367873 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006982487641367873 cfl multiplier : 0.6283506481311542        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0014e+04 |  512 |      1 | 2.558e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 692.089390834794 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 2.908907902961931, dt = 0.006982487641367873 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1359.00 ns (0.4%)
   gen split merge   : 731.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 906.00 ns  (0.3%)
   LB compute        : 293.31 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.782037597132586e-18,-3.437582250104265e-17,1.0312673566666153e-17)
    sum a = (-7.015164816236153e-17,-2.401009079056049e-17,-8.355816039085084e-17)
    sum e = 2.5920008302474935
    sum de = -7.318364664277155e-19
Info: CFL hydro = 0.008359406387928089 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008359406387928089 cfl multiplier : 0.7522337654207695        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0057e+04 |  512 |      1 | 2.553e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 984.705194675756 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 2.915890390603299, dt = 0.008359406387928089 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.90 us    (1.4%)
   patch tree reduce : 1284.00 ns (0.4%)
   gen split merge   : 718.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 830.00 ns  (0.3%)
   LB compute        : 270.56 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.37 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.528510792888856e-18,-3.4580736711642415e-17,9.527778956422427e-18)
    sum a = (-2.825474229584124e-17,8.710903092595812e-17,-6.697767340746452e-18)
    sum e = 2.5920009097069374
    sum de = -1.0842021724855044e-18
Info: CFL hydro = 0.00928056446445822 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00928056446445822 cfl multiplier : 0.8348225102805129         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0090e+04 |  512 |      1 | 2.549e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1180.839618559722 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.9242497969912273, dt = 0.00928056446445822 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 1283.00 ns (0.4%)
   gen split merge   : 746.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 793.00 ns  (0.3%)
   LB compute        : 275.25 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1901.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.74806173281717e-18,-3.317268335023549e-17,9.718788274160062e-18)
    sum a = (-1.0591137342141898e-17,-7.794497469335026e-17,1.1428358259735205e-17)
    sum e = 2.5920009736891627
    sum de = -1.6805133673525319e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011343468904826874
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.657314010980133e-18,-3.415919890698005e-17,9.805144977198532e-18)
    sum a = (-1.3751499938763346e-16,4.3555979135911916e-17,1.3395534681492904e-17)
    sum e = 2.5920006494678525
    sum de = -3.74049749507499e-18
Info: CFL hydro = 0.004951189659976953 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004951189659976953 cfl multiplier : 0.444940836760171         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4651e+04 |  512 |      1 | 3.495e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 956.0107039917455 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.9335303614556856, dt = 0.004951189659976953 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.3%)
   patch tree reduce : 1366.00 ns (0.4%)
   gen split merge   : 793.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1077.00 ns (0.3%)
   LB compute        : 291.95 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1948.00 ns (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.086630785351872e-17,-3.334832410217814e-17,9.913456774229835e-18)
    sum a = (1.5713992607135908e-17,6.692498118188173e-17,6.482314685030133e-17)
    sum e = 2.592000740609789
    sum de = 3.7947076036992655e-19
Info: CFL hydro = 0.007013850722409376 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007013850722409376 cfl multiplier : 0.6299605578401141        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0156e+04 |  512 |      1 | 2.540e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 701.6999330796206 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.9384815511156623, dt = 0.007013850722409376 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.6%)
   patch tree reduce : 1413.00 ns (0.5%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1160.00 ns (0.4%)
   LB compute        : 271.95 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0670175680516091e-17,-3.2856529996738715e-17,1.0520881041364838e-17)
    sum a = (3.399234019263453e-17,-1.1492759868780844e-16,2.2435178714808046e-17)
    sum e = 2.5920008368196177
    sum de = -1.111307226797642e-18
Info: CFL hydro = 0.008395321855400019 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008395321855400019 cfl multiplier : 0.7533070385600761        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0028e+04 |  512 |      1 | 2.556e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 987.702879702484 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 2.945495401838072, dt = 0.008395321855400019 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.4%)
   patch tree reduce : 1427.00 ns (0.5%)
   gen split merge   : 720.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 935.00 ns  (0.3%)
   LB compute        : 272.24 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1935.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0081779161508209e-17,-3.471832196733082e-17,1.0532590424827681e-17)
    sum a = (-9.6860020004641e-17,2.9484227559439804e-17,2.1592103105483316e-17)
    sum e = 2.5920009247624427
    sum de = -9.486769009248164e-19
Info: CFL hydro = 0.009319928123452012 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009319928123452012 cfl multiplier : 0.8355380257067173        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9653e+04 |  512 |      1 | 2.605e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1160.1099417265004 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.9538907236934717, dt = 0.009319928123452012 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.3%)
   patch tree reduce : 1086.00 ns (0.4%)
   gen split merge   : 759.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 883.00 ns  (0.3%)
   LB compute        : 292.34 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (70.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1586434936483592e-17,-3.3420044075888055e-17,1.0746286673024575e-17)
    sum a = (1.822916817495468e-16,-9.393267413893014e-17,-1.2716390440647983e-16)
    sum e = 2.592000999788901
    sum de = 2.710505431213761e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010891485039749902
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0321821522496499e-17,-3.4307029873198444e-17,9.979322056208328e-18)
    sum a = (-1.1896733598248943e-16,-4.44136914745652e-17,4.613497084360318e-17)
    sum e = 2.5920006538531553
    sum de = -7.047314121155779e-19
Info: CFL hydro = 0.004960409434559008 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004960409434559008 cfl multiplier : 0.4451793419022391        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4690e+04 |  512 |      1 | 3.485e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 962.6344840878967 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.9632106518169237, dt = 0.004960409434559008 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.5%)
   patch tree reduce : 1625.00 ns (0.5%)
   gen split merge   : 834.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1059.00 ns (0.4%)
   LB compute        : 284.71 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1885.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2215814297611426e-17,-3.443144207249116e-17,1.1185388552881204e-17)
    sum a = (-1.6238572986271293e-16,-3.3957212042246e-18,-4.238796813549328e-17)
    sum e = 2.5920007505164055
    sum de = 7.318364664277155e-19
Info: CFL hydro = 0.007017317062317304 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007017317062317304 cfl multiplier : 0.6301195612681595        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0255e+04 |  512 |      1 | 2.528e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 706.4403466150679 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.968171061251483, dt = 0.007017317062317304 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1173.00 ns (0.4%)
   gen split merge   : 842.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 934.00 ns  (0.3%)
   LB compute        : 296.56 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1898.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.365314111767546e-17,-3.411089770019582e-17,1.0509171657901994e-17)
    sum a = (2.171388069349689e-16,1.2993902828717373e-16,2.32314167902814e-17)
    sum e = 2.592000855030338
    sum de = -1.4365678785432934e-18
Info: CFL hydro = 0.008386107170444624 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008386107170444624 cfl multiplier : 0.7534130408454397        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7856e+04 |  512 |      1 | 2.867e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 881.0166025666975 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.9751883783138, dt = 0.008386107170444624 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.38 us    (1.7%)
   patch tree reduce : 1204.00 ns (0.4%)
   gen split merge   : 731.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 894.00 ns  (0.3%)
   LB compute        : 290.77 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0493071255640584e-17,-3.2433528519143496e-17,1.103316656786424e-17)
    sum a = (-5.854691731421724e-17,-6.355853343631424e-17,7.119305145408816e-17)
    sum e = 2.592000950961071
    sum de = 3.5236570605778894e-19
Info: CFL hydro = 0.009298857293310493 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009298857293310493 cfl multiplier : 0.8356086938969597        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9726e+04 |  512 |      1 | 2.595e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1163.1666525242633 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 2.9835744854842448, dt = 0.009298857293310493 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 1433.00 ns (0.5%)
   gen split merge   : 700.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 946.00 ns  (0.3%)
   LB compute        : 282.52 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1826.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2149949015632933e-17,-3.401429528662736e-17,1.171523815457487e-17)
    sum a = (1.9507832849097184e-17,-8.711781296355525e-17,1.9812276819131113e-17)
    sum e = 2.592001031821181
    sum de = -5.014435047745458e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011420196545964635
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1767930380157664e-17,-3.3803526384296175e-17,1.1557161477826483e-17)
    sum a = (8.639183118885895e-17,-6.564280369270037e-17,-4.7399584257590274e-17)
    sum e = 2.5920006573880916
    sum de = -1.7889335846010823e-18
Info: CFL hydro = 0.0049565456653801205 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0049565456653801205 cfl multiplier : 0.4452028979656532       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4782e+04 |  512 |      1 | 3.464e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 966.5105178077705 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.992873342777555, dt = 0.0049565456653801205 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.5%)
   patch tree reduce : 1237.00 ns (0.4%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1411.00 ns (0.5%)
   LB compute        : 273.23 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1943.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1062440026521348e-17,-3.447681593340968e-17,1.0948273537758624e-17)
    sum a = (-5.447205186914772e-17,-1.201148555618481e-16,1.4112148949418923e-16)
    sum e = 2.592000762448877
    sum de = -1.666960840196463e-18
Info: CFL hydro = 0.007017287339964706 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007017287339964706 cfl multiplier : 0.6301352653104355        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9564e+04 |  512 |      1 | 2.617e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 681.8273033934817 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 2.997829888442935, dt = 0.0021701115570649243 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.4%)
   patch tree reduce : 1372.00 ns (0.4%)
   gen split merge   : 758.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1002.00 ns (0.3%)
   LB compute        : 294.35 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1523497000370808e-17,-3.447974327927539e-17,1.1867460139591834e-17)
    sum a = (-2.208389721092274e-17,-1.9273645179840315e-17,-5.3254275989012e-17)
    sum e = 2.592000675597845
    sum de = 1.8295911660692887e-18
Info: CFL hydro = 0.008392250925780173 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008392250925780173 cfl multiplier : 0.753423510206957         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9667e+04 |  512 |      1 | 2.603e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 300.09322330200615 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 405                                                     [SPH][rank=0]
Info: time since start : 1744.7717534580001 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.1497180979635976 max=0.15032885919638359 delta=0.0006107612327859724
Number of particle pairs: 130816
Distance min=0.146293 max=1.991984 mean=0.806540
---------------- t = 3, dt = 0.008392250925780173 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 8.87 us    (1.6%)
   patch tree reduce : 1208.00 ns (0.2%)
   gen split merge   : 554.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 851.00 ns  (0.2%)
   LB compute        : 520.20 us  (95.9%)
   LB move op cnt    : 0
   LB apply          : 4.27 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.56 us    (76.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1826477297471882e-17,-3.4703685238002266e-17,1.1258572199523975e-17)
    sum a = (-5.756332910333839e-17,-1.5217514748311345e-16,-2.6627137994506e-17)
    sum e = 2.592000969891699
    sum de = 3.2526065174565133e-19
Info: CFL hydro = 0.009315068220382422 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009315068220382422 cfl multiplier : 0.8356156734713046        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6835e+04 |  512 |      1 | 3.041e-02 | 0.1% |   3.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 993.4175080526197 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.0083922509257803, dt = 0.009315068220382422 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.90 us    (1.2%)
   patch tree reduce : 1212.00 ns (0.4%)
   gen split merge   : 749.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 894.00 ns  (0.3%)
   LB compute        : 296.34 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2000.00 ns (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2379745666091234e-17,-3.668403471615567e-17,1.1176606515284071e-17)
    sum a = (-1.6411871861521377e-16,-1.8151886244099912e-16,1.9531251616022872e-17)
    sum e = 2.592001053538293
    sum de = -9.351243737687476e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011588724595964175
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2791769596690039e-17,-3.690504932901684e-17,1.1264426891255397e-17)
    sum a = (-9.208259155180088e-17,-1.0538445116559103e-17,2.950764632636549e-18)
    sum e = 2.5920006580058086
    sum de = 1.1248597539537109e-18
Info: CFL hydro = 0.00497127670292961 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00497127670292961 cfl multiplier : 0.4452052244904349         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4440e+04 |  512 |      1 | 3.546e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 945.7382118384697 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.017707319146163, dt = 0.00497127670292961 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1660.00 ns (0.6%)
   gen split merge   : 840.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 869.00 ns  (0.3%)
   LB compute        : 283.69 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.36 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3084504183261125e-17,-3.600049945651218e-17,1.1205879973941179e-17)
    sum a = (5.8265892111109e-17,-9.034960279930004e-17,-8.711781296355526e-18)
    sum e = 2.592000769425688
    sum de = -2.9408983928669308e-18
Info: CFL hydro = 0.007042718342526107 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007042718342526107 cfl multiplier : 0.6301368163269566        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9276e+04 |  512 |      1 | 2.656e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 673.7774676511785 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.0226785958490927, dt = 0.007042718342526107 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.99 us    (1.4%)
   patch tree reduce : 1783.00 ns (0.6%)
   gen split merge   : 669.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 819.00 ns  (0.3%)
   LB compute        : 275.23 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.67 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1846.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2241062655703183e-17,-3.6832597518840494e-17,1.1147333056626963e-17)
    sum a = (-4.234113060164191e-17,1.4791293190263844e-16,1.7559391440880034e-16)
    sum e = 2.592000885360479
    sum de = -5.55653613398821e-19
Info: CFL hydro = 0.008433583577720078 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008433583577720078 cfl multiplier : 0.753424544217971         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9976e+04 |  512 |      1 | 2.563e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 989.1772866956399 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.029721314191619, dt = 0.008433583577720078 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.82 us    (1.3%)
   patch tree reduce : 1054.00 ns (0.3%)
   gen split merge   : 618.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1141.00 ns (0.4%)
   LB compute        : 290.14 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2736424463916443e-17,-3.465538403121804e-17,1.327844084686447e-17)
    sum a = (1.1554819601133913e-16,-5.081872422874056e-17,-9.98810409380546e-18)
    sum e = 2.5920009867573066
    sum de = -1.0706496453294356e-18
Info: CFL hydro = 0.009372364995096265 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009372364995096265 cfl multiplier : 0.8356163628119807        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.0364e+04 |  512 |      1 | 4.940e-02 | 0.0% |   1.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 614.5735161408365 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.038154897769339, dt = 0.009372364995096265 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.93 us    (1.6%)
   patch tree reduce : 1206.00 ns (0.4%)
   gen split merge   : 891.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 895.00 ns  (0.3%)
   LB compute        : 284.67 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1964.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.121832119387045e-17,-3.618400745046893e-17,1.246463869619685e-17)
    sum a = (-1.7845100397373413e-17,1.9027748127120603e-16,2.866457071704076e-17)
    sum e = 2.5920010650743874
    sum de = -1.4365678785432934e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010702763327426387
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.192015236517463e-17,-3.495470514598697e-17,1.2657843523333768e-17)
    sum a = (9.133319101017889e-18,1.4533686754081289e-16,8.397969819551321e-17)
    sum e = 2.592000659135183
    sum de = 1.4907779871675686e-18
Info: CFL hydro = 0.004992405381943053 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004992405381943053 cfl multiplier : 0.4452054542706603        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4620e+04 |  512 |      1 | 3.502e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 963.4278750544612 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.047527262764435, dt = 0.004992405381943053 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.5%)
   patch tree reduce : 1433.00 ns (0.5%)
   gen split merge   : 834.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 911.00 ns  (0.3%)
   LB compute        : 292.22 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1775248744821942e-17,-3.464330872952198e-17,1.3255022079938783e-17)
    sum a = (-1.1320631931877045e-16,-3.0725422206501207e-17,-3.1287472612717695e-17)
    sum e = 2.5920007732601698
    sum de = -5.082197683525802e-19
Info: CFL hydro = 0.0070654932131751155 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070654932131751155 cfl multiplier : 0.6301369695137735       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9661e+04 |  512 |      1 | 2.604e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 690.1596254302967 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.0525196681463784, dt = 0.0070654932131751155 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.4%)
   patch tree reduce : 1090.00 ns (0.4%)
   gen split merge   : 732.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 882.00 ns  (0.3%)
   LB compute        : 280.26 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.62 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1912.00 ns (63.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2832752438809991e-17,-3.518834393789402e-17,1.2798356124887888e-17)
    sum a = (-5.109974943184881e-17,-1.3580542940205832e-16,9.321693807476383e-17)
    sum e = 2.5920008868523055
    sum de = 3.7269449679189215e-19
Info: CFL hydro = 0.00844818632958727 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00844818632958727 cfl multiplier : 0.7534246463425157         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9921e+04 |  512 |      1 | 2.570e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 989.6426488321295 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.0595851613595535, dt = 0.00844818632958727 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.4%)
   patch tree reduce : 1272.00 ns (0.4%)
   gen split merge   : 683.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 315.06 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2796892451955033e-17,-3.671440592951242e-17,1.3998567929829342e-17)
    sum a = (8.070107082591704e-17,-8.681336899352132e-17,3.410357933553154e-18)
    sum e = 2.5920009815876455
    sum de = 1.2265037076242269e-18
Info: CFL hydro = 0.009367936384357812 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009367936384357812 cfl multiplier : 0.8356164308950106        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9503e+04 |  512 |      1 | 2.625e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1158.5035939229945 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.068033347689141, dt = 0.009367936384357812 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.4%)
   patch tree reduce : 1288.00 ns (0.4%)
   gen split merge   : 783.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 984.00 ns  (0.3%)
   LB compute        : 302.43 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1773785071889086e-17,-3.722120268251361e-17,1.3670705192869726e-17)
    sum a = (-1.9601507916799932e-17,-5.0350348890226823e-17,8.641524995578464e-18)
    sum e = 2.592001049668293
    sum de = -1.683901499141549e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01004956762286196
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1945034805033173e-17,-3.6971646447461757e-17,1.3682414576332568e-17)
    sum a = (1.0070069778045365e-18,-1.4009106374945902e-16,-9.851104307290193e-17)
    sum e = 2.5920006597000467
    sum de = 2.608861477543245e-19
Info: CFL hydro = 0.004988733408996433 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004988733408996433 cfl multiplier : 0.44520547696500357       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4923e+04 |  512 |      1 | 3.431e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 982.9748050570208 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.0774012840734986, dt = 0.004988733408996433 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.4%)
   patch tree reduce : 1160.00 ns (0.4%)
   gen split merge   : 755.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 270.70 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1851.00 ns (63.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2031391508071643e-17,-3.814917132194395e-17,1.2692971673722298e-17)
    sum a = (-1.611913727495029e-16,-3.941378473593105e-17,5.492871782419861e-17)
    sum e = 2.5920007694033194
    sum de = -2.879912020664621e-20
Info: CFL hydro = 0.007059308520592904 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007059308520592904 cfl multiplier : 0.6301369846433357        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9778e+04 |  512 |      1 | 2.589e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 693.748136793131 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 3.082390017482495, dt = 0.007059308520592904 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.5%)
   patch tree reduce : 1525.00 ns (0.5%)
   gen split merge   : 755.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 286.39 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3436517523612856e-17,-3.816380805127251e-17,1.3459936290538543e-17)
    sum a = (-2.482389294122811e-17,2.6720813062208747e-17,-6.566622245962605e-17)
    sum e = 2.5920008755627477
    sum de = 2.7088113653192525e-18
Info: CFL hydro = 0.008438864018247281 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008438864018247281 cfl multiplier : 0.7534246564288903        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0504e+04 |  512 |      1 | 2.497e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1017.7251812033205 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.089449326003088, dt = 0.008438864018247281 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.3%)
   patch tree reduce : 1448.00 ns (0.4%)
   gen split merge   : 766.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 906.00 ns  (0.3%)
   LB compute        : 327.01 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.71 us    (72.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3120364170116083e-17,-3.7777398396998674e-17,1.2488057463122537e-17)
    sum a = (-8.758618830206899e-17,8.428414216554714e-17,1.6791255885717503e-17)
    sum e = 2.5920009622384677
    sum de = 6.623797647528629e-19
Info: CFL hydro = 0.009357781122260506 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009357781122260506 cfl multiplier : 0.8356164376192602        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9728e+04 |  512 |      1 | 2.595e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1170.5890621766189 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.0978881900213353, dt = 0.009357781122260506 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 1810.00 ns (0.6%)
   gen split merge   : 709.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 820.00 ns  (0.3%)
   LB compute        : 279.09 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1957.00 ns (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4305939245728984e-17,-3.6918222385412533e-17,1.297399687683054e-17)
    sum a = (-2.4706799106599675e-17,1.1013846085150547e-16,1.0070069778045365e-17)
    sum e = 2.59200102380736
    sum de = 4.472333961502706e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010648991229254258
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3896110824529463e-17,-3.6790882840254115e-17,1.2962287493367697e-17)
    sum a = (6.444844657949034e-17,1.6393136847980826e-17,-2.1709196940111752e-17)
    sum e = 2.5920006607653874
    sum de = -1.0299920638612292e-18
Info: CFL hydro = 0.004982896208094065 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004982896208094065 cfl multiplier : 0.4452054792064201        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4630e+04 |  512 |      1 | 3.500e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 962.5768121802903 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.107245971143596, dt = 0.004982896208094065 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.3%)
   patch tree reduce : 1740.00 ns (0.5%)
   gen split merge   : 721.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 987.00 ns  (0.3%)
   LB compute        : 313.82 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3158419666370324e-17,-3.7052880295235235e-17,1.2675407598528032e-17)
    sum a = (3.5854132163226634e-17,-1.086630785351872e-17,3.8196008855795326e-17)
    sum e = 2.592000762861501
    sum de = -1.2841019480375193e-18
Info: CFL hydro = 0.0070507408436773665 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070507408436773665 cfl multiplier : 0.6301369861376135       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9674e+04 |  512 |      1 | 2.602e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 689.2935803707715 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.11222886735169, dt = 0.0070507408436773665 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.5%)
   patch tree reduce : 1217.00 ns (0.4%)
   gen split merge   : 744.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1261.00 ns (0.4%)
   LB compute        : 275.22 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3178911087430301e-17,-3.738806139685913e-17,1.3202329854355987e-17)
    sum a = (-7.475270402679257e-17,-3.650985763714587e-17,-5.821905457725762e-17)
    sum e = 2.5920008617190895
    sum de = -5.89534931288993e-19
Info: CFL hydro = 0.008428516368786554 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008428516368786554 cfl multiplier : 0.7534246574250757        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9516e+04 |  512 |      1 | 2.623e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 967.5271710960443 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.1192796081953675, dt = 0.008428516368786554 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.4%)
   patch tree reduce : 1444.00 ns (0.5%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 966.00 ns  (0.3%)
   LB compute        : 299.10 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4112734418592066e-17,-3.728853163742496e-17,1.2329980786374151e-17)
    sum a = (1.0397932515004981e-16,-2.149842803778057e-17,-2.9179783589405875e-17)
    sum e = 2.5920009435525473
    sum de = -1.6737371037744975e-18
Info: CFL hydro = 0.009338787321520433 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009338787321520433 cfl multiplier : 0.8356164382833837        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9514e+04 |  512 |      1 | 2.624e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1156.4625260131372 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.1277081245641543, dt = 0.009338787321520433 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.4%)
   patch tree reduce : 1388.00 ns (0.5%)
   gen split merge   : 676.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 934.00 ns  (0.3%)
   LB compute        : 273.11 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1945.00 ns (64.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.23973097412855e-17,-3.7721778825550164e-17,1.2195322876551451e-17)
    sum a = (1.1944742070446602e-16,-8.554875557953423e-17,3.9203015833599864e-17)
    sum e = 2.59200100364357
    sum de = -6.776263578034403e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011089097926397815
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.22626518314628e-17,-3.803793217904694e-17,1.246463869619685e-17)
    sum a = (2.4102594919916954e-16,-3.0350721935690215e-17,-7.915543220882171e-17)
    sum e = 2.5920006629244217
    sum de = -1.3823577699190182e-18
Info: CFL hydro = 0.0049722332130513296 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0049722332130513296 cfl multiplier : 0.4452054794277946       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4484e+04 |  512 |      1 | 3.535e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 951.0709242256286 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.1370469118856747, dt = 0.0049722332130513296 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.5%)
   patch tree reduce : 1434.00 ns (0.5%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 986.00 ns  (0.3%)
   LB compute        : 283.11 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0351094981153607e-17,-3.7759834321804405e-17,1.1677182658320629e-17)
    sum a = (1.5146087509188e-16,-9.50801937182888e-18,1.5409548637101976e-17)
    sum e = 2.5920007585976883
    sum de = -7.860465750519907e-19
Info: CFL hydro = 0.007035226810569523 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007035226810569523 cfl multiplier : 0.6301369862851964        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0096e+04 |  512 |      1 | 2.548e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 702.5770495504826 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.1420191450987263, dt = 0.007035226810569523 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1591.00 ns (0.5%)
   gen split merge   : 751.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 927.00 ns  (0.3%)
   LB compute        : 279.25 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1993.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.57827567260594e-18,-3.804964156250978e-17,1.191722501930892e-17)
    sum a = (7.318364664277155e-17,1.5713992607135908e-17,-2.309090418872728e-17)
    sum e = 2.5920008540135298
    sum de = -3.2390539903004445e-18
Info: CFL hydro = 0.008409287027490622 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008409287027490622 cfl multiplier : 0.7534246575234643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9461e+04 |  512 |      1 | 2.631e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 962.6776414074984 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.149054371909296, dt = 0.008409287027490622 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1342.00 ns (0.4%)
   gen split merge   : 714.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 295.66 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.563638943277386e-18,-3.777154370526725e-17,1.1498614560512266e-17)
    sum a = (1.5349245312268334e-16,4.953069204782778e-17,-2.1311077902375075e-17)
    sum e = 2.5920009360573517
    sum de = -1.3823577699190182e-18
Info: CFL hydro = 0.009326158443872275 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009326158443872275 cfl multiplier : 0.8356164383489763        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9706e+04 |  512 |      1 | 2.598e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1165.153465444503 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.1574636589367864, dt = 0.009326158443872275 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 1732.00 ns (0.6%)
   gen split merge   : 756.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1360.00 ns (0.5%)
   LB compute        : 275.14 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.482296032756963e-18,-3.698116032152532e-17,1.1328828500301035e-17)
    sum a = (8.90205877762673e-17,7.79142375617603e-17,6.018623099901532e-17)
    sum e = 2.5920010009037897
    sum de = -2.981555974335137e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010903145415910951
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.74282981480523e-18,-3.718900187799079e-17,1.1803058530546196e-17)
    sum a = (-6.426987848168197e-17,5.162667168767676e-17,-1.0805419059511934e-16)
    sum e = 2.592000666034163
    sum de = -7.453889935837843e-19
Info: CFL hydro = 0.004971215828270556 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004971215828270556 cfl multiplier : 0.4452054794496587        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4812e+04 |  512 |      1 | 3.457e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 971.2833635527866 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.166789817380659, dt = 0.004971215828270556 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.4%)
   patch tree reduce : 2.25 us    (0.7%)
   gen split merge   : 793.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 993.00 ns  (0.3%)
   LB compute        : 286.98 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.823020439252538e-18,-3.7095326810288043e-17,1.0342312943556476e-17)
    sum a = (2.1402118358798684e-16,4.8582231987337464e-17,-5.587717788468893e-17)
    sum e = 2.592000760134127
    sum de = -1.9651164376299768e-18
Info: CFL hydro = 0.007038056941212395 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007038056941212395 cfl multiplier : 0.6301369862997724        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9246e+04 |  512 |      1 | 2.660e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 672.7051601997279 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.1717610332089294, dt = 0.007038056941212395 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.82 us    (1.6%)
   patch tree reduce : 1289.00 ns (0.4%)
   gen split merge   : 925.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 932.00 ns  (0.3%)
   LB compute        : 275.97 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.39 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1963.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.800224446046332e-18,-3.6670861659759966e-17,1.022229176306233e-17)
    sum a = (3.565068162555973e-17,-1.885210737517795e-18,6.847647449070848e-17)
    sum e = 2.5920008576992313
    sum de = 7.724940478959219e-19
Info: CFL hydro = 0.00841683616662353 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00841683616662353 cfl multiplier : 0.7534246575331816         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7517e+04 |  512 |      1 | 2.923e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 866.8479161480601 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.1787990901501417, dt = 0.00841683616662353 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.4%)
   patch tree reduce : 1550.00 ns (0.5%)
   gen split merge   : 749.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 895.00 ns  (0.3%)
   LB compute        : 280.95 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.39 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.955373776929008e-18,-3.6896267291419704e-17,1.1213198338605457e-17)
    sum a = (-7.570701877901431e-17,-3.857656381833774e-17,9.273831702572011e-18)
    sum e = 2.592000944516149
    sum de = 1.260385025514399e-18
Info: CFL hydro = 0.009326871986794213 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009326871986794213 cfl multiplier : 0.8356164383554544        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9703e+04 |  512 |      1 | 2.599e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1166.0635019947251 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.187215926316765, dt = 0.009326871986794213 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.4%)
   patch tree reduce : 1609.00 ns (0.5%)
   gen split merge   : 745.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 869.00 ns  (0.3%)
   LB compute        : 285.58 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1983.00 ns (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.176077002930438e-18,-3.738513405099342e-17,1.1055853498323498e-17)
    sum a = (9.413173365779848e-17,-5.6497775208219635e-18,-1.0889726620444406e-16)
    sum e = 2.5920010148430928
    sum de = 8.673617379884035e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010742641484191526
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.517424183145493e-18,-3.7268040216364986e-17,1.0528931242495543e-17)
    sum a = (-1.8076946189937716e-16,6.085952054812882e-17,-1.6472760655528163e-16)
    sum e = 2.5920006693720845
    sum de = 1.2874900798265365e-18
Info: CFL hydro = 0.004967149389588341 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004967149389588341 cfl multiplier : 0.44520547945181815       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4971e+04 |  512 |      1 | 3.420e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 981.7958928951152 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.1965427983035593, dt = 0.004967149389588341 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1501.00 ns (0.5%)
   gen split merge   : 636.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 881.00 ns  (0.3%)
   LB compute        : 280.39 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.47581856730606e-18,-3.641910991530883e-17,9.421296750557195e-18)
    sum a = (1.3154321382158329e-16,-1.1321217401050189e-16,-3.6626951471774306e-17)
    sum e = 2.5920007662085878
    sum de = -3.2526065174565133e-19
Info: CFL hydro = 0.0070290375271151164 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070290375271151164 cfl multiplier : 0.6301369863012121       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0085e+04 |  512 |      1 | 2.549e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 701.4566521722734 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.2015099476931477, dt = 0.0070290375271151164 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.4%)
   patch tree reduce : 1347.00 ns (0.5%)
   gen split merge   : 847.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 857.00 ns  (0.3%)
   LB compute        : 273.16 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1792.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.766248581730917e-18,-3.7715924133818745e-17,9.559430883595426e-18)
    sum a = (-1.1470512040201442e-16,-4.176590713902972e-17,-9.259780442416598e-17)
    sum e = 2.5920008680719167
    sum de = -4.0657581468206416e-20
Info: CFL hydro = 0.008397856846117047 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008397856846117047 cfl multiplier : 0.7534246575341413        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9724e+04 |  512 |      1 | 2.596e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 974.810784714733 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 3.2085389852202626, dt = 0.008397856846117047 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.94 us    (1.3%)
   patch tree reduce : 1164.00 ns (0.4%)
   gen split merge   : 729.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 892.00 ns  (0.3%)
   LB compute        : 290.87 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.710006236562929e-18,-3.7710069442087326e-17,8.621765410984916e-18)
    sum a = (-3.796182118653846e-17,7.452437104926712e-17,3.9718228705964977e-17)
    sum e = 2.5920009587403725
    sum de = -1.3417001884508117e-18
Info: CFL hydro = 0.009303537951884112 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009303537951884112 cfl multiplier : 0.8356164383560941        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0380e+04 |  512 |      1 | 2.512e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1203.3870395346007 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.2169368420663798, dt = 0.009303537951884112 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.5%)
   patch tree reduce : 1644.00 ns (0.6%)
   gen split merge   : 814.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 924.00 ns  (0.3%)
   LB compute        : 273.30 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.718788274160062e-18,-3.6533276404071555e-17,9.60754913126305e-18)
    sum a = (-7.472928525986688e-17,-2.6770577941925832e-17,5.21770127104304e-17)
    sum e = 2.592001031631879
    sum de = 1.734723475976807e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010677499424280458
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.815390687728521e-18,-3.7039707238839533e-17,9.62657687939017e-18)
    sum a = (-5.964759935972453e-17,1.1446215069516042e-16,-5.728230390023015e-17)
    sum e = 2.5920006720420403
    sum de = -5.963111948670274e-19
Info: CFL hydro = 0.004953789640448506 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004953789640448506 cfl multiplier : 0.4452054794520313        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4740e+04 |  512 |      1 | 3.474e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 964.2073010116844 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.2262403800182637, dt = 0.004953789640448506 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.5%)
   patch tree reduce : 1386.00 ns (0.5%)
   gen split merge   : 625.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1299.00 ns (0.5%)
   LB compute        : 265.45 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1946.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0078851815642498e-17,-3.5827786050435237e-17,8.739591082079778e-18)
    sum a = (7.227031473266976e-17,1.990595188683386e-17,-6.00457183974612e-17)
    sum e = 2.592000772856935
    sum de = 2.710505431213761e-20
Info: CFL hydro = 0.007009451995471878 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007009451995471878 cfl multiplier : 0.6301369863013542        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0383e+04 |  512 |      1 | 2.512e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 709.9843017476466 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.2311941696587123, dt = 0.007009451995471878 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1405.00 ns (0.5%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 905.00 ns  (0.3%)
   LB compute        : 287.85 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.262122319109167e-18,-3.58980423512123e-17,8.458565878971535e-18)
    sum a = (7.412039731979902e-17,-4.3295445353863647e-17,-1.0173112352518387e-16)
    sum e = 2.5920008775642587
    sum de = -2.0057740190981832e-18
Info: CFL hydro = 0.00837936634069428 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00837936634069428 cfl multiplier : 0.7534246575342362         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0114e+04 |  512 |      1 | 2.546e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 991.298479151573 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 3.238203621654184, dt = 0.00837936634069428 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 1310.00 ns (0.4%)
   gen split merge   : 688.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1183.00 ns (0.4%)
   LB compute        : 293.98 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.41 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.43 us    (69.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.536140544412873e-18,-3.6594750667251484e-17,7.417894423711323e-18)
    sum a = (-5.4425214335296344e-17,9.016225266389455e-18,-4.7399584257590274e-17)
    sum e = 2.592000969127617
    sum de = 3.7947076036992655e-19
Info: CFL hydro = 0.0092947448259505 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0092947448259505 cfl multiplier : 0.8356164383561575          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9802e+04 |  512 |      1 | 2.586e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1166.6958347146958 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.2465829879948784, dt = 0.0092947448259505 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 1195.00 ns (0.4%)
   gen split merge   : 712.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 917.00 ns  (0.3%)
   LB compute        : 279.66 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.67 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1949.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.584130364337362e-18,-3.634007157693464e-17,7.289091205620047e-18)
    sum a = (-2.1650650022797536e-16,9.07945593708881e-17,-4.262215580475015e-17)
    sum e = 2.592001040311902
    sum de = 2.3852447794681098e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011177307803147943
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0220828090129474e-17,-3.5985862727183626e-17,7.280309168022914e-18)
    sum a = (-6.341802083476011e-17,-7.806645954677726e-17,1.9343901480617376e-17)
    sum e = 2.5920006735927683
    sum de = 1.0028870095490916e-18
Info: CFL hydro = 0.004951213275293208 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004951213275293208 cfl multiplier : 0.4452054794520525        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4545e+04 |  512 |      1 | 3.520e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 950.5916921999994 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.255877732820829, dt = 0.004951213275293208 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.74 us    (1.6%)
   patch tree reduce : 1207.00 ns (0.4%)
   gen split merge   : 968.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1197.00 ns (0.4%)
   LB compute        : 282.41 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.837345781721351e-18,-3.734122386300775e-17,7.719411047879543e-18)
    sum a = (5.592401541854031e-17,-7.049048844631756e-18,5.3956838996782606e-17)
    sum e = 2.5920007766275175
    sum de = -4.0657581468206416e-19
Info: CFL hydro = 0.007005089158540928 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007005089158540928 cfl multiplier : 0.6301369863013684        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0059e+04 |  512 |      1 | 2.552e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 698.322317251404 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 3.260828946096122, dt = 0.007005089158540928 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.4%)
   patch tree reduce : 1184.00 ns (0.4%)
   gen split merge   : 723.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 910.00 ns  (0.3%)
   LB compute        : 274.42 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1959.00 ns (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.174301943137841e-18,-3.712460026894515e-17,8.155585581870461e-18)
    sum a = (5.854691731421724e-17,7.223518658228122e-17,8.594687461727091e-17)
    sum e = 2.592000880322066
    sum de = -7.860465750519907e-19
Info: CFL hydro = 0.008372843545876358 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008372843545876358 cfl multiplier : 0.7534246575342456        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8333e+04 |  512 |      1 | 2.793e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 902.9796865724046 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.267834035254663, dt = 0.008372843545876358 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1398.00 ns (0.5%)
   gen split merge   : 752.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1026.00 ns (0.3%)
   LB compute        : 290.36 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.48 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.786428615931152e-18,-3.623761447163476e-17,9.118682371689335e-18)
    sum a = (6.590041012888292e-17,-3.981190377366772e-17,-1.2646134139870923e-18)
    sum e = 2.592000967785004
    sum de = -9.0801931945661e-19
Info: CFL hydro = 0.009285552708772474 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009285552708772474 cfl multiplier : 0.8356164383561637        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9915e+04 |  512 |      1 | 2.571e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1172.3984658338259 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.276206878800539, dt = 0.009285552708772474 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1181.00 ns (0.4%)
   gen split merge   : 641.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 871.00 ns  (0.3%)
   LB compute        : 300.05 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.36708632066807e-18,-3.694017747940537e-17,8.843511860312513e-18)
    sum a = (1.1414306999579792e-16,5.0725049161037816e-17,6.013939346516395e-17)
    sum e = 2.592001032020475
    sum de = 3.1170812458958252e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010493545431999849
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.949939534804273e-18,-3.652156702060871e-17,8.99573384532948e-18)
    sum a = (1.097403418137688e-16,6.018623099901532e-17,-5.273906311664689e-17)
    sum e = 2.5920006742902757
    sum de = -1.1519648082658485e-18
Info: CFL hydro = 0.0049497474350677344 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0049497474350677344 cfl multiplier : 0.4452054794520546       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4511e+04 |  512 |      1 | 3.528e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 947.4340791978638 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.2854924315093115, dt = 0.0049497474350677344 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.5%)
   patch tree reduce : 1448.00 ns (0.5%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 285.74 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.63 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1868.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.33300139360571e-18,-3.60590463738264e-17,8.149730890139039e-18)
    sum a = (-1.444001168637854e-16,7.025630077706069e-20,-3.7235839411842166e-18)
    sum e = 2.592000775057614
    sum de = 4.743384504624082e-19
Info: CFL hydro = 0.007007827344731078 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007007827344731078 cfl multiplier : 0.6301369863013697        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9431e+04 |  512 |      1 | 2.635e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 676.2584168485077 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.2904421789443794, dt = 0.007007827344731078 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.73 us    (1.6%)
   patch tree reduce : 1631.00 ns (0.6%)
   gen split merge   : 732.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 906.00 ns  (0.3%)
   LB compute        : 275.17 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1898.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.977437933668786e-18,-3.6348853614531775e-17,8.442465476710125e-18)
    sum a = (-2.429931256209272e-16,3.744660831417335e-17,6.088879400678593e-17)
    sum e = 2.5920008735775593
    sum de = 4.87890977618477e-19
Info: CFL hydro = 0.008384124018410082 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008384124018410082 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9741e+04 |  512 |      1 | 2.594e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 972.7023901455889 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.2974500062891106, dt = 0.008384124018410082 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.4%)
   patch tree reduce : 1306.00 ns (0.4%)
   gen split merge   : 730.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1228.00 ns (0.4%)
   LB compute        : 291.32 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1332030284841657e-17,-3.598439905425077e-17,9.145028484480733e-18)
    sum a = (-2.1404752970077823e-17,-1.4102781442648648e-16,5.669683472708798e-17)
    sum e = 2.5920009547095253
    sum de = -1.2468324983583301e-18
Info: CFL hydro = 0.009308422248530604 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009308422248530604 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9912e+04 |  512 |      1 | 2.571e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1173.8404825886946 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.3058341303075207, dt = 0.009308422248530604 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.6%)
   patch tree reduce : 1487.00 ns (0.5%)
   gen split merge   : 691.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 932.00 ns  (0.3%)
   LB compute        : 264.49 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.072213606963246e-17,-3.81345345926154e-17,9.57827567260594e-18)
    sum a = (2.5901156219809705e-17,-1.324331269647594e-16,8.660260009119014e-17)
    sum e = 2.592001012767421
    sum de = -6.911788849595091e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010595820182504564
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0236196655924457e-17,-3.816966274300393e-17,9.71293358242864e-18)
    sum a = (-2.271620391791629e-17,2.5713806084404212e-17,7.030313831091206e-17)
    sum e = 2.592000674987108
    sum de = -5.421010862427522e-20
Info: CFL hydro = 0.004967719385340154 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004967719385340154 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4287e+04 |  512 |      1 | 3.584e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 935.0540981168529 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.3151425525560514, dt = 0.004967719385340154 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.80 us    (1.6%)
   patch tree reduce : 1577.00 ns (0.5%)
   gen split merge   : 799.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 912.00 ns  (0.3%)
   LB compute        : 290.23 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.41 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.45 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0676762208713942e-17,-3.7153873727602257e-17,1.0046651011119678e-17)
    sum a = (-9.48928435828833e-17,1.2803039878273027e-16,-6.660297313665353e-17)
    sum e = 2.592000770380734
    sum de = 2.303929616531697e-19
Info: CFL hydro = 0.007037626194300748 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007037626194300748 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9655e+04 |  512 |      1 | 2.605e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 686.539505669797 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 3.3201102719413917, dt = 0.007037626194300748 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.91 us    (1.6%)
   patch tree reduce : 1410.00 ns (0.5%)
   gen split merge   : 1096.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 936.00 ns  (0.3%)
   LB compute        : 283.41 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.70 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1459827227791597e-17,-3.602099087757216e-17,9.127464409286467e-18)
    sum a = (1.9512516602482321e-16,3.882831556278887e-17,-1.0908461633984957e-16)
    sum e = 2.592000862770536
    sum de = -1.212951180468158e-18
Info: CFL hydro = 0.008426892786218016 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008426892786218016 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9821e+04 |  512 |      1 | 2.583e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 980.7989564456301 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.3271478981356926, dt = 0.008426892786218016 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.5%)
   patch tree reduce : 1190.00 ns (0.4%)
   gen split merge   : 765.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1270.00 ns (0.4%)
   LB compute        : 275.53 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.77 us    (64.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.830338803916815e-18,-3.611905696407347e-17,8.067765205899136e-18)
    sum a = (1.878185107440089e-17,-2.0144823309475867e-16,2.757559805499632e-18)
    sum e = 2.592000939150988
    sum de = -2.913793338554793e-19
Info: CFL hydro = 0.00936095196524368 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00936095196524368 cfl multiplier : 0.8356164383561643         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9576e+04 |  512 |      1 | 2.615e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1159.9171008197643 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.3355747909219104, dt = 0.00936095196524368 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.5%)
   patch tree reduce : 1330.00 ns (0.5%)
   gen split merge   : 629.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1217.00 ns (0.4%)
   LB compute        : 277.62 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1970.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.379216153737601e-18,-3.873610416801898e-17,8.594687461727091e-18)
    sum a = (9.09584907393679e-17,-1.0559522006792221e-16,1.313255382126002e-16)
    sum e = 2.5920009952130187
    sum de = 6.098637220230962e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010905126231909304
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.04988974384513e-18,-3.834823084081229e-17,9.291395777766275e-18)
    sum a = (-3.5502850659341336e-17,-1.4074678922337825e-17,7.038126185370322e-17)
    sum e = 2.5920006766205277
    sum de = -6.572975670693371e-19
Info: CFL hydro = 0.004988970825132189 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004988970825132189 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4844e+04 |  512 |      1 | 3.449e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 977.0330439027332 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.344935742887154, dt = 0.004988970825132189 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.4%)
   patch tree reduce : 1768.00 ns (0.6%)
   gen split merge   : 702.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 293.16 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.857837202781328e-18,-3.804598238017764e-17,9.308959852960541e-18)
    sum a = (-3.0584909604947086e-17,-5.4354958034519286e-17,-6.845305572378279e-17)
    sum e = 2.592000766262312
    sum de = -8.809142651444724e-19
Info: CFL hydro = 0.007062632034812813 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007062632034812813 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9791e+04 |  512 |      1 | 2.587e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 694.2586245809006 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.3499247137122863, dt = 0.007062632034812813 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1108.00 ns (0.4%)
   gen split merge   : 814.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 934.00 ns  (0.3%)
   LB compute        : 276.51 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1891.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0184236266808088e-17,-3.8546924441447416e-17,8.45417486017297e-18)
    sum a = (-1.3690611144756558e-16,-5.526828994462107e-17,3.345370855334373e-17)
    sum e = 2.592000854842849
    sum de = 8.504210790433175e-19
Info: CFL hydro = 0.008447982685397388 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008447982685397388 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9358e+04 |  512 |      1 | 2.645e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 961.3203067065301 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.356987345747099, dt = 0.008447982685397388 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.6%)
   patch tree reduce : 1698.00 ns (0.6%)
   gen split merge   : 750.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 278.40 us  (93.3%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1972.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1557161477826483e-17,-3.9118305762610854e-17,9.109900334092203e-18)
    sum a = (-1.4238610290817633e-17,-8.828875130983959e-17,-1.0479898199244885e-17)
    sum e = 2.5920009305356406
    sum de = 2.998496633280223e-19
Info: CFL hydro = 0.009372315454557861 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009372315454557861 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9399e+04 |  512 |      1 | 2.639e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1152.274708609123 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.3654353284324965, dt = 0.009372315454557861 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.02 us    (1.3%)
   patch tree reduce : 1778.00 ns (0.6%)
   gen split merge   : 1248.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 982.00 ns  (0.3%)
   LB compute        : 286.79 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.104194860546137e-17,-4.0072094507372353e-17,8.7586188302069e-18)
    sum a = (2.5994831287512453e-17,8.948310842304963e-17,5.3394788590566124e-17)
    sum e = 2.592000990046766
    sum de = -2.2556487385382018e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011378802927375298
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0904363349772961e-17,-3.9311281890852013e-17,9.162592559674999e-18)
    sum a = (2.903927098785175e-18,1.8243219435110093e-17,-2.5760643618255583e-18)
    sum e = 2.5920006796643777
    sum de = -1.3387355731354217e-18
Info: CFL hydro = 0.004987393907074689 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004987393907074689 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4795e+04 |  512 |      1 | 3.461e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 975.0087750323802 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.3748076438870545, dt = 0.004987393907074689 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.3%)
   patch tree reduce : 1151.00 ns (0.4%)
   gen split merge   : 805.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 300.85 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.113855101902983e-17,-3.942494524204407e-17,8.782037597132586e-18)
    sum a = (1.1845212311012432e-16,-9.770309561396573e-17,-5.648606582475679e-17)
    sum e = 2.5920007665693805
    sum de = -1.1794933790516132e-18
Info: CFL hydro = 0.0070540507974541046 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070540507974541046 cfl multiplier : 0.6301369863013698       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8070e+04 |  512 |      1 | 2.834e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 633.6543905019938 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.3797950377941293, dt = 0.0070540507974541046 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.3%)
   patch tree reduce : 1215.00 ns (0.4%)
   gen split merge   : 663.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1256.00 ns (0.4%)
   LB compute        : 323.52 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.70 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.771480499742858e-18,-4.025942177288827e-17,8.260970033036053e-18)
    sum a = (-7.372227828206234e-17,5.1427612168808425e-17,4.643941481363711e-17)
    sum e = 2.592000856579992
    sum de = -2.5055234579782204e-18
Info: CFL hydro = 0.008427567009427026 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008427567009427026 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9850e+04 |  512 |      1 | 2.579e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 984.5378254958885 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.386849088591583, dt = 0.008427567009427026 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1087.00 ns (0.4%)
   gen split merge   : 720.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 273.12 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1281990966449661e-17,-3.927473580730978e-17,9.074772183703672e-18)
    sum a = (9.011541513004318e-17,1.2299536389370758e-16,-8.126312123213353e-17)
    sum e = 2.592000937304511
    sum de = -1.734723475976807e-18
Info: CFL hydro = 0.009341282409548131 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009341282409548131 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9368e+04 |  512 |      1 | 2.644e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1147.6654650025262 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.3952766556010103, dt = 0.009341282409548131 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.71 us    (1.6%)
   patch tree reduce : 1520.00 ns (0.5%)
   gen split merge   : 631.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 925.00 ns  (0.3%)
   LB compute        : 280.48 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1849.00 ns (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.598767093665917e-18,-3.792157018088493e-17,7.734047777208098e-18)
    sum a = (-3.5713619561672514e-17,4.850026630309756e-17,2.594799375366108e-17)
    sum e = 2.5920010052682203
    sum de = 2.6156377411212794e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.012410883425141257
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.021936441719662e-17,-3.8423609996854344e-17,8.140948852541908e-18)
    sum a = (7.510398553067787e-17,-9.173131004791557e-17,4.9741460950158966e-17)
    sum e = 2.5920006836660887
    sum de = -1.0232158002831948e-18
Info: CFL hydro = 0.00497674485169678 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00497674485169678 cfl multiplier : 0.44520547945205474        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4995e+04 |  512 |      1 | 3.415e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 984.8650696740386 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.4046179380105586, dt = 0.00497674485169678 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.49 us    (1.6%)
   patch tree reduce : 1389.00 ns (0.5%)
   gen split merge   : 699.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 932.00 ns  (0.3%)
   LB compute        : 272.25 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.72 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.505092025963168e-18,-3.9642117713456494e-17,8.547849927875717e-18)
    sum a = (3.362934930528638e-17,5.772726047181819e-17,5.409735159833673e-18)
    sum e = 2.592000773822404
    sum de = -2.710505431213761e-19
Info: CFL hydro = 0.007044049577890427 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007044049577890427 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9245e+04 |  512 |      1 | 2.660e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 673.4372736679039 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.4095946828622554, dt = 0.007044049577890427 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.87 us    (1.4%)
   patch tree reduce : 1329.00 ns (0.4%)
   gen split merge   : 761.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1104.00 ns (0.3%)
   LB compute        : 321.31 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.82 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.121609717555046e-18,-3.861754666045769e-17,8.568341348935693e-18)
    sum a = (1.2425997730769467e-16,-1.0430718788700943e-16,-8.964703979152943e-17)
    sum e = 2.592000871406147
    sum de = 7.928228386300251e-19
Info: CFL hydro = 0.008424277723430676 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008424277723430676 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8619e+04 |  512 |      1 | 2.750e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 922.1602392836513 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.4166387324401457, dt = 0.008424277723430676 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.65 us    (1.5%)
   patch tree reduce : 1392.00 ns (0.5%)
   gen split merge   : 642.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1243.00 ns (0.4%)
   LB compute        : 291.40 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.780885311059472e-18,-4.0385663563347054e-17,7.482296032756963e-18)
    sum a = (9.47289122144035e-17,-1.8969201209806386e-17,8.599371215112229e-17)
    sum e = 2.5920009619420927
    sum de = -3.3881317890172014e-20
Info: CFL hydro = 0.009349187478289772 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009349187478289772 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9893e+04 |  512 |      1 | 2.574e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1178.3174346312057 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.4250630101635764, dt = 0.009349187478289772 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.75 us    (1.5%)
   patch tree reduce : 1195.00 ns (0.4%)
   gen split merge   : 728.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1246.00 ns (0.4%)
   LB compute        : 300.95 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1933.00 ns (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.318364664277155e-18,-4.00885379579774e-17,8.984024461866635e-18)
    sum a = (-9.266806072494305e-17,1.1182461207015494e-16,4.730590918988753e-18)
    sum e = 2.5920010401298694
    sum de = 1.1587410718438829e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.012027402538906313
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.997508905122074e-18,-3.931425497649688e-17,8.644452341444175e-18)
    sum a = (-8.639183118885895e-17,-5.053769902563232e-17,-7.245766486807525e-17)
    sum e = 2.592000687583835
    sum de = 2.7037291676357267e-18
Info: CFL hydro = 0.004987729323372576 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004987729323372576 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4353e+04 |  512 |      1 | 3.567e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 943.5094538232295 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.434412197641866, dt = 0.004987729323372576 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.5%)
   patch tree reduce : 1280.00 ns (0.4%)
   gen split merge   : 789.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1092.00 ns (0.4%)
   LB compute        : 279.82 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.42 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1935.00 ns (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.483448318830077e-18,-4.0186604044478714e-17,7.868705687030796e-18)
    sum a = (-1.9753729901816896e-17,-2.4659961572748302e-17,4.4308307023399603e-17)
    sum e = 2.592000786724065
    sum de = -1.1519648082658485e-18
Info: CFL hydro = 0.007064683611516368 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007064683611516368 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9649e+04 |  512 |      1 | 2.606e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 689.0952897692368 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.4393999269652387, dt = 0.007064683611516368 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1818.00 ns (0.6%)
   gen split merge   : 1066.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 923.00 ns  (0.3%)
   LB compute        : 299.84 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.413192018053017e-18,-4.070035324391097e-17,8.433683439112994e-18)
    sum a = (1.7716297179282136e-17,8.173149657064727e-18,-1.2271433869059933e-17)
    sum e = 2.5920008946659725
    sum de = 3.1170812458958252e-19
Info: CFL hydro = 0.008457466130882066 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008457466130882066 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9484e+04 |  512 |      1 | 2.628e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 967.8387183443381 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.446464610576755, dt = 0.008457466130882066 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.96 us    (1.7%)
   patch tree reduce : 1201.00 ns (0.4%)
   gen split merge   : 986.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 943.00 ns  (0.3%)
   LB compute        : 274.25 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1933.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.792594694522314e-18,-4.061985123260392e-17,8.051664803637725e-18)
    sum a = (-8.955336472382669e-17,4.248164320319603e-17,-1.8266638202035778e-18)
    sum e = 2.592000994097302
    sum de = -8.131516293641283e-19
Info: CFL hydro = 0.009397068271807175 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009397068271807175 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0043e+04 |  512 |      1 | 2.554e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1191.9157228463423 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.4549220767076374, dt = 0.009397068271807175 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.5%)
   patch tree reduce : 1328.00 ns (0.5%)
   gen split merge   : 727.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 854.00 ns  (0.3%)
   LB compute        : 273.81 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1935.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.531438138754566e-18,-3.9864595999250516e-17,8.206814134520402e-18)
    sum a = (1.693293942561791e-16,-4.6931208919076537e-17,7.025630077706068e-19)
    sum e = 2.5920010772997655
    sum de = 1.260385025514399e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010180479379080936
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.337081025544535e-18,-4.0447137826526977e-17,8.143876198407618e-18)
    sum a = (-1.2557142825553314e-16,-6.491682191800407e-17,4.604129577590044e-17)
    sum e = 2.5920006902367283
    sum de = 1.883801274693564e-18
Info: CFL hydro = 0.005007696832417397 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005007696832417397 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4815e+04 |  512 |      1 | 3.456e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 978.8619580784962 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.4643191449794446, dt = 0.005007696832417397 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.5%)
   patch tree reduce : 1095.00 ns (0.4%)
   gen split merge   : 698.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 921.00 ns  (0.3%)
   LB compute        : 275.49 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1867.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0216437071330909e-17,-4.0912585819175004e-17,8.648843360242742e-18)
    sum a = (-1.2206446790841152e-16,-9.807779588477671e-17,3.606490106555782e-18)
    sum e = 2.5920007990033564
    sum de = 5.827586677109586e-19
Info: CFL hydro = 0.0070876663721661775 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070876663721661775 cfl multiplier : 0.6301369863013698       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0234e+04 |  512 |      1 | 2.530e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 712.4370164634031 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.469326841811862, dt = 0.0070876663721661775 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1629.00 ns (0.5%)
   gen split merge   : 647.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 934.00 ns  (0.3%)
   LB compute        : 289.11 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.46 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0965837612952889e-17,-4.1609294135214194e-17,8.490034847027927e-18)
    sum a = (-8.239234489983149e-17,-2.378175781303504e-17,-3.470661258386798e-17)
    sum e = 2.5920009129629893
    sum de = -7.047314121155779e-19
Info: CFL hydro = 0.008470272032298932 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008470272032298932 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0038e+04 |  512 |      1 | 2.555e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 998.6144941410605 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.4764145081840283, dt = 0.008470272032298932 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1231.00 ns (0.4%)
   gen split merge   : 581.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 782.00 ns  (0.3%)
   LB compute        : 269.83 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1988.00 ns (63.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1639127162066388e-17,-4.1594657405885635e-17,8.190347814025778e-18)
    sum a = (-7.257475870270369e-17,3.983532254059341e-17,2.1076890233118207e-17)
    sum e = 2.5920010121746055
    sum de = -4.0657581468206416e-19
Info: CFL hydro = 0.00937596342825382 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00937596342825382 cfl multiplier : 0.8356164383561643         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9862e+04 |  512 |      1 | 2.578e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1182.9330769026951 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.484884780216327, dt = 0.00937596342825382 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.4%)
   patch tree reduce : 1259.00 ns (0.4%)
   gen split merge   : 599.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 764.00 ns  (0.2%)
   LB compute        : 293.80 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.47 us    (70.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2259724485597089e-17,-4.085403890186079e-17,8.526626670349313e-18)
    sum a = (2.143929565129321e-16,5.081872422874056e-17,2.0233814623793477e-17)
    sum e = 2.5920010861102356
    sum de = -6.776263578034403e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010514835010973757
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0889726620444406e-17,-4.0625705924335344e-17,8.546523474280316e-18)
    sum a = (-3.9384511277273935e-17,-9.475233098132918e-17,1.3161347012236035e-17)
    sum e = 2.592000690798276
    sum de = -9.215718466126788e-19
Info: CFL hydro = 0.004987259344362162 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004987259344362162 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4771e+04 |  512 |      1 | 3.466e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 973.7958510956241 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.494260743644581, dt = 0.004987259344362162 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.4%)
   patch tree reduce : 1214.00 ns (0.4%)
   gen split merge   : 1024.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 909.00 ns  (0.3%)
   LB compute        : 290.62 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2236305718671403e-17,-4.1972285022562336e-17,8.541629317911081e-18)
    sum a = (4.262215580475015e-17,-9.50801937182888e-18,-4.941359821319935e-17)
    sum e = 2.592000801720024
    sum de = -6.2341624917916505e-19
Info: CFL hydro = 0.0070528818350208446 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070528818350208446 cfl multiplier : 0.6301369863013698       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9912e+04 |  512 |      1 | 2.571e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 698.2620831694882 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.4992480029889435, dt = 0.0007519970110565488 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.5%)
   patch tree reduce : 1391.00 ns (0.5%)
   gen split merge   : 626.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1250.00 ns (0.4%)
   LB compute        : 291.64 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2072374350191595e-17,-4.162393086454275e-17,8.332507047629362e-18)
    sum a = (-1.41812343118497e-16,3.4964219020050535e-17,-5.559615268158069e-17)
    sum e = 2.592000693296608
    sum de = -1.6940658945086007e-18
Info: CFL hydro = 0.008432266151721999 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008432266151721999 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9672e+04 |  512 |      1 | 2.603e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 104.01580683088932 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 473                                                     [SPH][rank=0]
Info: time since start : 1747.35886538 (s)                                            [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14973760109992273 max=0.1502940982079608 delta=0.0005564971080380676
Number of particle pairs: 130816
Distance min=0.146540 max=1.917854 mean=0.806717
---------------- t = 3.5, dt = 0.008432266151721999 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.57 us    (1.8%)
   patch tree reduce : 1104.00 ns (0.2%)
   gen split merge   : 611.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 1177.00 ns (0.2%)
   LB compute        : 505.81 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 4.64 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (82.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3366261222835795e-17,-4.1287286089985996e-17,7.833577536642266e-18)
    sum a = (1.0826495949745052e-16,5.386316392907986e-18,-1.3479842242425378e-16)
    sum e = 2.5920010052652174
    sum de = 6.776263578034403e-20
Info: CFL hydro = 0.009335440110731766 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009335440110731766 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6199e+04 |  512 |      1 | 3.161e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 960.4432135118175 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.508432266151722, dt = 0.009335440110731766 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.5%)
   patch tree reduce : 2.11 us    (0.7%)
   gen split merge   : 872.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1046.00 ns (0.3%)
   LB compute        : 290.15 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1258572199523975e-17,-4.170589654878265e-17,6.232319348098425e-18)
    sum a = (-8.919037383647854e-17,8.443050945883269e-17,5.114658696570018e-17)
    sum e = 2.5920010674785754
    sum de = -3.3881317890172014e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010860755400203762
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2154340034431499e-17,-4.1205320405746095e-17,7.096618214949558e-18)
    sum a = (4.286805285746986e-17,-1.3061817252801867e-17,-9.170789128098988e-17)
    sum e = 2.5920006908503086
    sum de = -5.55653613398821e-19
Info: CFL hydro = 0.004966599010180958 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004966599010180958 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4477e+04 |  512 |      1 | 3.537e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 950.2508731961319 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.517767706262454, dt = 0.004966599010180958 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.3%)
   patch tree reduce : 1258.00 ns (0.4%)
   gen split merge   : 721.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1016.00 ns (0.3%)
   LB compute        : 298.14 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.137566603415241e-17,-4.172346062397692e-17,5.9234843592659295e-18)
    sum a = (-6.086537523986024e-17,-1.9859114352982488e-17,8.140363383368765e-17)
    sum e = 2.592000796734007
    sum de = 1.0570971181733668e-18
Info: CFL hydro = 0.00702439613219803 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00702439613219803 cfl multiplier : 0.6301369863013698         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9465e+04 |  512 |      1 | 2.630e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 679.7461196024058 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.522734305272635, dt = 0.00702439613219803 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.3%)
   patch tree reduce : 1593.00 ns (0.5%)
   gen split merge   : 706.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 315.77 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1979.00 ns (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1978699282488847e-17,-4.1855191187933904e-17,6.855844017494839e-18)
    sum a = (-2.0290019664415126e-16,-1.1305116998788777e-16,3.817259008886964e-17)
    sum e = 2.5920008955251355
    sum de = -1.7618285302889447e-18
Info: CFL hydro = 0.008391370341182957 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008391370341182957 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9682e+04 |  512 |      1 | 2.601e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 972.079285893256 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 3.529758701404833, dt = 0.008391370341182957 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.84 us    (1.6%)
   patch tree reduce : 1214.00 ns (0.4%)
   gen split merge   : 942.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 817.00 ns  (0.3%)
   LB compute        : 291.92 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4215191523891945e-17,-4.319298824856377e-17,7.150042276998781e-18)
    sum a = (5.011616122096995e-18,-6.127520366105976e-17,1.0121591065281877e-16)
    sum e = 2.592000971058119
    sum de = 7.047314121155779e-19
Info: CFL hydro = 0.009299534031446715 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009299534031446715 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9535e+04 |  512 |      1 | 2.621e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1152.6205636852653 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.538150071746016, dt = 0.009299534031446715 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.5%)
   patch tree reduce : 1355.00 ns (0.4%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 931.00 ns  (0.3%)
   LB compute        : 285.85 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1979.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3208184546087409e-17,-4.3617453399091845e-17,8.392700596993042e-18)
    sum a = (-8.545508051183148e-17,1.4690738859776676e-16,6.599408519658567e-17)
    sum e = 2.592001016807187
    sum de = 1.870248747537495e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010387532615947659
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3729252110183942e-17,-4.2434805669344655e-17,8.244869630774643e-18)
    sum a = (6.175528838303634e-17,1.0329725356333919e-16,-1.138620447926897e-16)
    sum e = 2.592000689376245
    sum de = -4.336808689942018e-19
Info: CFL hydro = 0.004952894673241943 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004952894673241943 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4457e+04 |  512 |      1 | 3.541e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 945.328221336488 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 3.5474496057774627, dt = 0.004952894673241943 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 2.19 us    (0.7%)
   gen split merge   : 925.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 996.00 ns  (0.3%)
   LB compute        : 282.38 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1882.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2807138162485021e-17,-4.208645151132506e-17,6.788515062583489e-18)
    sum a = (9.967027203572342e-17,-2.7227243896976728e-17,5.372265132752574e-17)
    sum e = 2.59200078175484
    sum de = -2.2632720350634905e-18
Info: CFL hydro = 0.007009055625934157 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007009055625934157 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9878e+04 |  512 |      1 | 2.576e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 692.2469827565072 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.5524025004507047, dt = 0.007009055625934157 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.3%)
   patch tree reduce : 1804.00 ns (0.5%)
   gen split merge   : 729.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1040.00 ns (0.3%)
   LB compute        : 318.48 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2046028237400197e-17,-4.265142926340726e-17,7.567189062862578e-18)
    sum a = (2.5245430745890472e-17,-4.2089378857190775e-17,1.1732802229769134e-17)
    sum e = 2.592000863354289
    sum de = 2.371692252312041e-18
Info: CFL hydro = 0.00837993334276325 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00837993334276325 cfl multiplier : 0.7534246575342465         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9145e+04 |  512 |      1 | 2.674e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 943.515998477628 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 3.559411556076639, dt = 0.00837993334276325 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.4%)
   patch tree reduce : 1702.00 ns (0.6%)
   gen split merge   : 755.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 921.00 ns  (0.3%)
   LB compute        : 274.35 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1921.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.215726738029721e-17,-4.316078744404095e-17,7.60524455911682e-18)
    sum a = (6.643904176817373e-17,-1.008236463068135e-16,-7.543184826763749e-17)
    sum e = 2.5920009226526406
    sum de = 1.6263032587282567e-19
Info: CFL hydro = 0.00928133569795294 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00928133569795294 cfl multiplier : 0.8356164383561643         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9113e+04 |  512 |      1 | 2.679e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1126.190400484962 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.567791489419402, dt = 0.00928133569795294 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.89 us    (1.3%)
   patch tree reduce : 1492.00 ns (0.5%)
   gen split merge   : 755.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 931.00 ns  (0.3%)
   LB compute        : 273.58 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1120986943835564e-17,-4.4363926594848113e-17,6.5982375813122826e-18)
    sum a = (-1.2606322236097257e-16,-2.5854318685958333e-17,4.049104801451264e-17)
    sum e = 2.5920009554196057
    sum de = -2.710505431213761e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01089275579878805
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2075301696057306e-17,-4.384285903075158e-17,7.075394957423153e-18)
    sum a = (-3.9039084465120056e-17,-1.75172376604138e-17,-2.3207998023355715e-17)
    sum e = 2.592000688826821
    sum de = -2.642742795433417e-19
Info: CFL hydro = 0.004938782887365535 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004938782887365535 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4904e+04 |  512 |      1 | 3.435e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 972.6508820520964 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.577072825117355, dt = 0.004938782887365535 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.4%)
   patch tree reduce : 1263.00 ns (0.4%)
   gen split merge   : 987.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1020.00 ns (0.3%)
   LB compute        : 280.16 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.206066496672875e-17,-4.392775206085719e-17,6.5572547391923305e-18)
    sum a = (1.1737485983154273e-16,-5.6439228290905416e-18,-1.7266656854308948e-16)
    sum e = 2.592000763841263
    sum de = -4.946672411965114e-19
Info: CFL hydro = 0.006985778286121807 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006985778286121807 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0137e+04 |  512 |      1 | 2.543e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 699.2671536516383 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.582011608004721, dt = 0.006985778286121807 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.71 us    (1.4%)
   patch tree reduce : 1247.00 ns (0.4%)
   gen split merge   : 692.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1308.00 ns (0.4%)
   LB compute        : 310.49 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0655538951187538e-17,-4.3939461444320036e-17,5.0525989642169474e-18)
    sum a = (-9.547831275602547e-17,7.286749328927477e-17,7.838261290027404e-17)
    sum e = 2.5920008292636956
    sum de = -7.453889935837843e-19
Info: CFL hydro = 0.008346722594799249 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008346722594799249 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9862e+04 |  512 |      1 | 2.578e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 975.6000625825276 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.588997386290843, dt = 0.008346722594799249 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1331.00 ns (0.5%)
   gen split merge   : 686.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 844.00 ns  (0.3%)
   LB compute        : 274.16 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1936.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2201177568282873e-17,-4.319884294029519e-17,6.615801656506548e-18)
    sum a = (-4.309053114326389e-18,1.3712858973335962e-16,-1.5819377058301497e-17)
    sum e = 2.5920008776787853
    sum de = 1.1926223897340549e-18
Info: CFL hydro = 0.009252454554209042 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009252454554209042 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9715e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1157.0583045303795 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.597344108885642, dt = 0.009252454554209042 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1278.00 ns (0.4%)
   gen split merge   : 741.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 886.00 ns  (0.3%)
   LB compute        : 273.96 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.73 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1841114026800437e-17,-4.157709333069137e-17,6.170845084918497e-18)
    sum a = (-6.107614414219142e-17,7.632176141081359e-17,-8.228622861219948e-17)
    sum e = 2.592000908676327
    sum de = -1.4568966692773966e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01100439024557567
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2359254245031259e-17,-4.196057563909949e-17,5.84298234795888e-18)
    sum a = (-1.9629610437110755e-16,4.426146948954823e-18,1.3920663937978112e-16)
    sum e = 2.5920006904670574
    sum de = -1.917682592583736e-18
Info: CFL hydro = 0.004929690922631124 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004929690922631124 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4719e+04 |  512 |      1 | 3.479e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 957.5400633594728 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.606596563439851, dt = 0.004929690922631124 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.4%)
   patch tree reduce : 1257.00 ns (0.4%)
   gen split merge   : 745.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 292.59 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.36 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (69.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3631186023682628e-17,-4.235576733097046e-17,7.722338393745254e-18)
    sum a = (3.4519262448462486e-17,1.5170677214459972e-16,-4.625206467823162e-17)
    sum e = 2.592000751758437
    sum de = -2.371692252312041e-19
Info: CFL hydro = 0.006977635875387043 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006977635875387043 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8706e+04 |  512 |      1 | 2.737e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 648.3724393554759 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.611526254362482, dt = 0.006977635875387043 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.12 us    (1.6%)
   patch tree reduce : 1209.00 ns (0.4%)
   gen split merge   : 758.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1060.00 ns (0.3%)
   LB compute        : 310.38 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2952041782837709e-17,-4.074279975896378e-17,6.931955010003321e-18)
    sum a = (1.788725417783965e-16,-2.1287659135449388e-17,-1.1844041372666148e-17)
    sum e = 2.5920008101224132
    sum de = -4.3029273720518457e-19
Info: CFL hydro = 0.008345040824831269 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008345040824831269 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9993e+04 |  512 |      1 | 2.561e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 980.8718734812519 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.6185038902378692, dt = 0.008345040824831269 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.5%)
   patch tree reduce : 1831.00 ns (0.6%)
   gen split merge   : 702.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 891.00 ns  (0.3%)
   LB compute        : 274.83 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1936.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0910218041504383e-17,-4.1913738105248123e-17,7.049048844631756e-18)
    sum a = (8.182517163835001e-17,-3.955429733748517e-17,2.757559805499632e-17)
    sum e = 2.59200085989773
    sum de = 4.1674021004911577e-19
Info: CFL hydro = 0.009261301895004707 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009261301895004707 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9812e+04 |  512 |      1 | 2.584e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1162.5174570978932 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.6268489310627006, dt = 0.009261301895004707 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.4%)
   patch tree reduce : 2.23 us    (0.8%)
   gen split merge   : 784.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 954.00 ns  (0.3%)
   LB compute        : 273.77 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.068042139104608e-17,-4.235576733097046e-17,7.373984235725662e-18)
    sum a = (-1.5175360967845107e-17,3.5713619561672514e-17,-2.839525489739536e-17)
    sum e = 2.5920009017104295
    sum de = 3.6994163971331567e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010410315754351767
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.114147836489554e-17,-4.198399440602518e-17,7.10174107021455e-18)
    sum a = (8.266824724767474e-17,-8.404995449629027e-17,4.4706426061136283e-17)
    sum e = 2.592000694592994
    sum de = 1.800580287625829e-18
Info: CFL hydro = 0.004940683232266764 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004940683232266764 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4599e+04 |  512 |      1 | 3.507e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 950.6729742647506 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.636110232957705, dt = 0.004940683232266764 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.86 us    (1.6%)
   patch tree reduce : 1212.00 ns (0.4%)
   gen split merge   : 800.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 984.00 ns  (0.3%)
   LB compute        : 280.19 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0393541496206416e-17,-4.284609776347703e-17,7.67842820575959e-18)
    sum a = (-1.3264389586709058e-16,3.990557884137047e-17,2.489414924200517e-17)
    sum e = 2.5920007525797972
    sum de = -1.4484263398048536e-19
Info: CFL hydro = 0.00699793222337694 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00699793222337694 cfl multiplier : 0.6301369863013698         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9517e+04 |  512 |      1 | 2.623e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 677.9884031437764 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.641050916189972, dt = 0.00699793222337694 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.3%)
   patch tree reduce : 1861.00 ns (0.5%)
   gen split merge   : 647.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 333.25 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1546915767296494e-17,-4.2329421218179066e-17,7.81015876971658e-18)
    sum a = (1.1255059384485122e-16,-7.095886378483129e-18,9.234019798798343e-17)
    sum e = 2.592000816921491
    sum de = -1.6398557858843255e-18
Info: CFL hydro = 0.008377259558125376 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008377259558125376 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9701e+04 |  512 |      1 | 2.599e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 969.3536780818312 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.6480488484133486, dt = 0.008377259558125376 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.02 us    (1.7%)
   patch tree reduce : 2.11 us    (0.7%)
   gen split merge   : 713.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 983.00 ns  (0.3%)
   LB compute        : 281.14 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.934680031756237e-18,-4.2494816259591726e-17,8.790819634729719e-18)
    sum a = (-3.100644740960945e-17,2.845380181470958e-17,5.2692225582795515e-17)
    sum e = 2.592000880419756
    sum de = -1.2671612890924333e-18
Info: CFL hydro = 0.009307427869446664 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009307427869446664 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9766e+04 |  512 |      1 | 2.590e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1164.270887360222 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.656426107971474, dt = 0.009307427869446664 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.94 us    (1.4%)
   patch tree reduce : 1473.00 ns (0.5%)
   gen split merge   : 672.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1012.00 ns (0.3%)
   LB compute        : 276.03 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0533505220410716e-17,-4.2136216391042145e-17,9.145028484480733e-18)
    sum a = (-9.433079317666682e-17,6.967083160391852e-17,-4.323104374481801e-17)
    sum e = 2.5920009424432786
    sum de = -2.188733135705112e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.0116940804909999
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.109445787192756e-17,-4.198253073309233e-17,8.65908907077273e-18)
    sum a = (-4.126386732306031e-17,5.519803364384401e-17,-2.723602593457386e-17)
    sum e = 2.592000700512807
    sum de = -2.3107058801097313e-18
Info: CFL hydro = 0.004967720831290732 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004967720831290732 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4479e+04 |  512 |      1 | 3.536e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 947.5156564554827 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.665733535840921, dt = 0.004967720831290732 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.5%)
   patch tree reduce : 1302.00 ns (0.4%)
   gen split merge   : 796.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1081.00 ns (0.4%)
   LB compute        : 287.64 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1223032391123079e-17,-4.164295861266987e-17,8.552240946674283e-18)
    sum a = (-6.6743485738207655e-18,1.5381446116791152e-16,7.264501500348075e-17)
    sum e = 2.5920007681665944
    sum de = 1.4907779871675686e-19
Info: CFL hydro = 0.007030853016878739 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007030853016878739 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9705e+04 |  512 |      1 | 2.598e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 688.294290388187 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 3.6707012566722117, dt = 0.007030853016878739 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.3%)
   patch tree reduce : 1605.00 ns (0.5%)
   gen split merge   : 686.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1044.00 ns (0.3%)
   LB compute        : 306.10 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0808675731787537e-17,-4.0362244796421366e-17,9.37628880787189e-18)
    sum a = (2.8383545513932515e-17,6.116981920989417e-17,-8.547849927875717e-17)
    sum e = 2.5920008500352214
    sum de = 5.149960319306146e-19
Info: CFL hydro = 0.008407162795494371 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008407162795494371 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9552e+04 |  512 |      1 | 2.619e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 966.5578584994516 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.6777321096890905, dt = 0.008407162795494371 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.08 us    (1.4%)
   patch tree reduce : 1110.00 ns (0.4%)
   gen split merge   : 810.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 979.00 ns  (0.3%)
   LB compute        : 278.27 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0654075278254681e-17,-4.025320116292363e-17,7.972626465263532e-18)
    sum a = (-8.54082429779801e-17,1.9952789420685236e-17,4.683753385137379e-17)
    sum e = 2.5920009341412826
    sum de = -8.267041565201971e-19
Info: CFL hydro = 0.009327428790406118 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009327428790406118 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9911e+04 |  512 |      1 | 2.571e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1177.0198058444053 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.686139272484585, dt = 0.009327428790406118 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.4%)
   patch tree reduce : 970.00 ns  (0.3%)
   gen split merge   : 757.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 873.00 ns  (0.3%)
   LB compute        : 278.77 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.72 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1966.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1962598880227437e-17,-4.018074935274729e-17,9.076235856636527e-18)
    sum a = (8.07947458936198e-17,1.788725417783965e-16,-1.1147333056626963e-16)
    sum e = 2.5920010163167024
    sum de = 2.7511630126819675e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01223876253533876
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.117367916941836e-17,-3.947525899911097e-17,8.335617352611679e-18)
    sum a = (8.051372069051154e-17,1.0287864310454254e-16,-6.313699563165187e-17)
    sum e = 2.592000706549888
    sum de = -4.811147140404426e-19
Info: CFL hydro = 0.004973487114576503 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004973487114576503 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4626e+04 |  512 |      1 | 3.501e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 959.1981775998742 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.695466701274991, dt = 0.004973487114576503 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.5%)
   patch tree reduce : 1351.00 ns (0.4%)
   gen split merge   : 741.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1633.00 ns (0.5%)
   LB compute        : 284.00 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0749214018890286e-17,-3.927839498964192e-17,8.110211720951943e-18)
    sum a = (1.0885042867059269e-16,1.415664460657773e-16,9.536121892139704e-17)
    sum e = 2.5920007931795737
    sum de = 7.453889935837843e-20
Info: CFL hydro = 0.007042493173482262 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007042493173482262 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8803e+04 |  512 |      1 | 2.723e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 657.5510767038558 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.7004401883895675, dt = 0.007042493173482262 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.4%)
   patch tree reduce : 1170.00 ns (0.4%)
   gen split merge   : 699.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 903.00 ns  (0.3%)
   LB compute        : 309.56 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.97566287387619e-18,-3.81583192777743e-17,9.39604839246544e-18)
    sum a = (1.1428358259735205e-17,1.7821681630447728e-16,-8.009218288584918e-18)
    sum e = 2.592000897174836
    sum de = -2.1751806085490433e-18
Info: CFL hydro = 0.008426888111702028 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008426888111702028 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9851e+04 |  512 |      1 | 2.579e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 982.9726631340983 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.7074826815630497, dt = 0.008426888111702028 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.4%)
   patch tree reduce : 1193.00 ns (0.4%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 279.28 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1974.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.025449256758515e-17,-3.650308814983141e-17,8.742518427945489e-18)
    sum a = (1.193420362533004e-16,8.789063227210292e-17,1.5456386170953351e-18)
    sum e = 2.5920010009858085
    sum de = -6.640738306473715e-19
Info: CFL hydro = 0.009356831502298013 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009356831502298013 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9703e+04 |  512 |      1 | 2.599e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1167.4474665188243 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.7159095696747517, dt = 0.009356831502298013 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.5%)
   patch tree reduce : 1046.00 ns (0.4%)
   gen split merge   : 619.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 878.00 ns  (0.3%)
   LB compute        : 277.42 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.410264672187306e-18,-3.611687288961897e-17,8.796857285577746e-18)
    sum a = (1.0351094981153607e-17,2.3723210895720825e-17,6.412058384253072e-17)
    sum e = 2.592001096342517
    sum de = 2.710505431213761e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.012153442150479749
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.036716687449431e-18,-3.64796922527953e-17,9.232665901335452e-18)
    sum a = (-9.358139263504483e-17,2.0833335057091063e-16,-5.0022486153267207e-17)
    sum e = 2.5920007108285894
    sum de = 5.89534931288993e-19
Info: CFL hydro = 0.00499334801808597 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00499334801808597 cfl multiplier : 0.44520547945205474        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4511e+04 |  512 |      1 | 3.528e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 954.6967582707497 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.7252664011770498, dt = 0.00499334801808597 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.4%)
   patch tree reduce : 1132.00 ns (0.4%)
   gen split merge   : 693.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 959.00 ns  (0.3%)
   LB compute        : 270.84 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1973.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.873937605042737e-18,-3.457762640666009e-17,8.379161622364129e-18)
    sum a = (2.650067665310729e-16,-8.077132712669411e-17,-9.484600604903192e-17)
    sum e = 2.5920008192513144
    sum de = -2.439454888092385e-18
Info: CFL hydro = 0.007073756111887095 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007073756111887095 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0238e+04 |  512 |      1 | 2.530e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 710.5332796314744 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.730259749195136, dt = 0.007073756111887095 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.3%)
   patch tree reduce : 1049.00 ns (0.3%)
   gen split merge   : 739.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 825.00 ns  (0.3%)
   LB compute        : 298.90 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.271527130425781e-18,-3.592146111813799e-17,7.548161314735458e-18)
    sum a = (-3.576045709552389e-17,9.899112779487851e-17,6.763339888138375e-17)
    sum e = 2.5920009415082634
    sum de = 1.395910297075087e-18
Info: CFL hydro = 0.008467089854894024 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008467089854894024 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9783e+04 |  512 |      1 | 2.588e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 983.9775115532797 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.737333505307023, dt = 0.008467089854894024 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.4%)
   patch tree reduce : 1407.00 ns (0.5%)
   gen split merge   : 749.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 902.00 ns  (0.3%)
   LB compute        : 277.73 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.55955931133856e-18,-3.4421928198427596e-17,8.697144567026971e-18)
    sum a = (-2.591286560327255e-17,-6.442502781256465e-17,-1.6435290628447063e-16)
    sum e = 2.5920010555136073
    sum de = -1.043544591017298e-18
Info: CFL hydro = 0.009397731717936921 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009397731717936921 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9561e+04 |  512 |      1 | 2.617e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1164.548627871478 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.745800595161917, dt = 0.009397731717936921 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1057.00 ns (0.3%)
   gen split merge   : 768.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1830.00 ns (0.6%)
   LB compute        : 296.89 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.716172315154091e-18,-3.5829981559834524e-17,6.219146291702726e-18)
    sum a = (1.3865080958352926e-16,-1.0215266132984624e-16,1.0566547636869927e-16)
    sum e = 2.5920011492717068
    sum de = -7.318364664277155e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010775208788740867
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.991654213390653e-18,-3.59192656087387e-17,7.480832359824107e-18)
    sum a = (1.0187163612673799e-18,3.793840241961277e-18,-3.3441999169880885e-17)
    sum e = 2.5920007121612327
    sum de = 2.168404344971009e-19
Info: CFL hydro = 0.005013273854341325 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005013273854341325 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4686e+04 |  512 |      1 | 3.486e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 970.4482873641607 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.755198326879854, dt = 0.005013273854341325 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 2.05 us    (0.7%)
   gen split merge   : 740.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 970.00 ns  (0.3%)
   LB compute        : 286.35 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.585905424129958e-18,-3.5506509841673474e-17,6.64068409636509e-18)
    sum a = (-4.44956571588051e-19,5.57600840500605e-17,-8.693046282814976e-17)
    sum e = 2.592000835460688
    sum de = -1.3145951341386741e-18
Info: CFL hydro = 0.007097921783438641 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007097921783438641 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9881e+04 |  512 |      1 | 2.575e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 700.7944246586875 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.7602116007341952, dt = 0.007097921783438641 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.4%)
   patch tree reduce : 1059.00 ns (0.3%)
   gen split merge   : 682.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 828.00 ns  (0.3%)
   LB compute        : 307.30 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.569805021868549e-18,-3.48602982418178e-17,5.8561554043545794e-18)
    sum a = (1.2774937357962202e-17,1.3709346158297108e-16,-7.831235659949698e-17)
    sum e = 2.5920009628419405
    sum de = 6.640738306473715e-19
Info: CFL hydro = 0.008490410787990697 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008490410787990697 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9421e+04 |  512 |      1 | 2.636e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 969.254279580455 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 3.767309522517634, dt = 0.008490410787990697 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1083.00 ns (0.3%)
   gen split merge   : 680.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 887.00 ns  (0.3%)
   LB compute        : 293.58 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.38684590526162e-18,-3.353713791051649e-17,5.245803791353865e-18)
    sum a = (-6.688399833976177e-17,4.885154780698287e-17,-2.997602166487923e-17)
    sum e = 2.5920010710946197
    sum de = 7.318364664277155e-19
Info: CFL hydro = 0.00941810473652578 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00941810473652578 cfl multiplier : 0.8356164383561643         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9497e+04 |  512 |      1 | 2.626e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1163.951881530881 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.775799933305625, dt = 0.00941810473652578 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.6%)
   patch tree reduce : 1122.00 ns (0.4%)
   gen split merge   : 861.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 933.00 ns  (0.3%)
   LB compute        : 275.93 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.358724732677626e-18,-3.342443509468662e-17,5.242876445488154e-18)
    sum a = (-9.397365698105009e-17,-8.126312123213353e-18,-2.1685778173186066e-16)
    sum e = 2.5920011478223217
    sum de = -6.369687763352339e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011153403578242063
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.494846315433181e-18,-3.370692397072772e-17,4.332471881252076e-18)
    sum a = (1.1160798847609233e-16,-2.2645947617139227e-17,-9.334720496578797e-17)
    sum e = 2.592000710506355
    sum de = -4.0657581468206416e-19
Info: CFL hydro = 0.005016427798341143 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005016427798341143 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4736e+04 |  512 |      1 | 3.474e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 975.8441778396085 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.7852180380421507, dt = 0.005016427798341143 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1071.00 ns (0.4%)
   gen split merge   : 674.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1094.00 ns (0.4%)
   LB compute        : 289.84 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.938961987807858e-18,-3.378742598203477e-17,4.38223676096916e-18)
    sum a = (3.875220457028039e-17,9.547831275602547e-17,2.3887142264200634e-18)
    sum e = 2.592000833892168
    sum de = 1.9109063290057016e-18
Info: CFL hydro = 0.007099206202840015 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007099206202840015 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9116e+04 |  512 |      1 | 2.678e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 674.2412809293276 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.790234465840492, dt = 0.007099206202840015 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.84 us    (1.5%)
   patch tree reduce : 1353.00 ns (0.4%)
   gen split merge   : 690.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1029.00 ns (0.3%)
   LB compute        : 297.70 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.54 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.786740002790892e-18,-3.284189326741016e-17,4.6369158512860054e-18)
    sum a = (-6.195434790190468e-17,1.23487157999147e-16,-5.470623953840459e-17)
    sum e = 2.5920009497331304
    sum de = -2.846030702774449e-19
Info: CFL hydro = 0.008485779227261035 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008485779227261035 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9588e+04 |  512 |      1 | 2.614e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 977.7717728125124 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.7973336720433317, dt = 0.008485779227261035 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.70 us    (1.5%)
   patch tree reduce : 1174.00 ns (0.4%)
   gen split merge   : 1057.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1058.00 ns (0.3%)
   LB compute        : 287.77 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.757155157274043e-18,-3.171779245497719e-17,3.908006730724001e-18)
    sum a = (4.593152030593628e-17,-1.8126125600481657e-17,7.400330348517058e-17)
    sum e = 2.5920010379900145
    sum de = -1.429791614965259e-18
Info: CFL hydro = 0.009402270320535549 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009402270320535549 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9121e+04 |  512 |      1 | 2.678e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1140.8393947936972 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.805819451270593, dt = 0.009402270320535549 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 1204.00 ns (0.4%)
   gen split merge   : 788.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1008.00 ns (0.3%)
   LB compute        : 273.50 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.52 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.804304077985158e-18,-3.242913750034493e-17,5.251658483085287e-18)
    sum a = (2.1144219188029555e-17,3.606490106555782e-18,7.212980213111565e-18)
    sum e = 2.592001088823731
    sum de = 2.7308342219478643e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011177388870618341
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.985799521659232e-18,-3.226227878599941e-17,4.938432475454224e-18)
    sum a = (5.849129774276873e-17,-1.0170770475825818e-16,-1.0044309134427109e-16)
    sum e = 2.592000707332547
    sum de = 6.166399856011306e-19
Info: CFL hydro = 0.00500619598337935 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00500619598337935 cfl multiplier : 0.44520547945205474        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4871e+04 |  512 |      1 | 3.443e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 983.1345751199786 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.8152217215911284, dt = 0.00500619598337935 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.5%)
   patch tree reduce : 1148.00 ns (0.4%)
   gen split merge   : 1055.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 1027.00 ns (0.3%)
   LB compute        : 279.51 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.56 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.565725389929722e-18,-3.3301486568326764e-17,4.069010753338098e-18)
    sum a = (3.0883498883249596e-17,-7.290262143966331e-17,1.4800660697034118e-17)
    sum e = 2.592000815162973
    sum de = -2.520770051028798e-18
Info: CFL hydro = 0.007081783019221683 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007081783019221683 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9459e+04 |  512 |      1 | 2.631e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 684.9394746086297 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.8202279175745075, dt = 0.007081783019221683 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.27 us    (1.8%)
   patch tree reduce : 1251.00 ns (0.4%)
   gen split merge   : 931.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1008.00 ns (0.3%)
   LB compute        : 282.74 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.347638122934263e-18,-3.3784498636169055e-17,4.341253918849208e-18)
    sum a = (-9.32769486650109e-17,-2.696671011492846e-17,-4.4987451264244524e-17)
    sum e = 2.592000907327973
    sum de = -7.453889935837843e-19
Info: CFL hydro = 0.008455730784281523 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008455730784281523 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9789e+04 |  512 |      1 | 2.587e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 985.3813487311446 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.8273097005937293, dt = 0.008455730784281523 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1173.00 ns (0.4%)
   gen split merge   : 744.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1668.00 ns (0.6%)
   LB compute        : 279.56 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.650307033175597e-18,-3.3819626786557587e-17,3.840677775812651e-18)
    sum a = (8.855221243775357e-17,-6.44133184291018e-17,-3.695481420873392e-17)
    sum e = 2.592000969818174
    sum de = -7.386127300057499e-19
Info: CFL hydro = 0.009365822430764583 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009365822430764583 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0037e+04 |  512 |      1 | 2.555e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1191.2883259299463 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.835765431378011, dt = 0.009365822430764583 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.02 us    (1.3%)
   patch tree reduce : 1226.00 ns (0.4%)
   gen split merge   : 713.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1008.00 ns (0.3%)
   LB compute        : 290.79 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1880.00 ns (62.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.171997370991612e-18,-3.4659775050016606e-17,3.530379114047299e-18)
    sum a = (4.761035315992146e-17,-7.067783858172306e-17,9.673121678654972e-17)
    sum e = 2.5920009983881918
    sum de = -9.012430558785756e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011727056844891634
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.122232491274527e-18,-3.4630501591359494e-17,4.221232738355063e-18)
    sum a = (-1.3114509478384662e-18,-2.9976021664879226e-18,1.1322973808569613e-17)
    sum e = 2.5920007048502356
    sum de = 1.6601845766184287e-18
Info: CFL hydro = 0.004985802001348202 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004985802001348202 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4386e+04 |  512 |      1 | 3.559e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 947.3738842557807 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.8451312538087756, dt = 0.004985802001348202 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1285.00 ns (0.4%)
   gen split merge   : 679.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1445.00 ns (0.5%)
   LB compute        : 279.74 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (69.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.373984235725662e-18,-3.4282147433339905e-17,3.6708917156014206e-18)
    sum a = (2.3354365316641257e-17,7.161458925875053e-17,-1.9062876277509133e-16)
    sum e = 2.592000787841555
    sum de = 1.1858461261560205e-19
Info: CFL hydro = 0.0070538590995023465 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070538590995023465 cfl multiplier : 0.6301369863013698       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9584e+04 |  512 |      1 | 2.614e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 686.5349528525317 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.8501170558101236, dt = 0.0070538590995023465 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.5%)
   patch tree reduce : 1246.00 ns (0.4%)
   gen split merge   : 733.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1133.00 ns (0.4%)
   LB compute        : 287.44 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.50 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.106132089013118e-18,-3.3643986034614934e-17,1.86764666232353e-18)
    sum a = (-8.603469499324223e-17,-1.8184672517795873e-17,-4.7270781039499e-17)
    sum e = 2.592000854382994
    sum de = -3.049318610115481e-19
Info: CFL hydro = 0.008424997362740508 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008424997362740508 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9857e+04 |  512 |      1 | 2.578e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 984.8391282965072 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.857170914909626, dt = 0.008424997362740508 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 2.08 us    (0.7%)
   gen split merge   : 852.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1004.00 ns (0.3%)
   LB compute        : 273.41 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1973.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.149730890139039e-18,-3.4241164591219954e-17,1.955467038294856e-18)
    sum a = (1.6931768487271626e-17,-3.509302223814181e-17,1.758749396119086e-17)
    sum e = 2.592000897061793
    sum de = -1.6263032587282567e-18
Info: CFL hydro = 0.009332005733822533 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009332005733822533 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0079e+04 |  512 |      1 | 2.550e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1189.4522535701942 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.8655959122723664, dt = 0.009332005733822533 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1392.00 ns (0.5%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1133.00 ns (0.4%)
   LB compute        : 285.12 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.575971100459711e-18,-3.453975386952246e-17,2.4940986775856545e-18)
    sum a = (1.1845212311012432e-16,-4.7938215896881074e-17,-1.3861129041434218e-16)
    sum e = 2.5920009156860804
    sum de = -1.675431169669006e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011344235510872169
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.340319758269986e-18,-3.459830078683668e-17,1.7212793690379868e-18)
    sum a = (7.118134207062532e-17,-3.9747502164622083e-17,5.5386847452182364e-17)
    sum e = 2.592000704793688
    sum de = 1.277325684459485e-18
Info: CFL hydro = 0.004967737186195218 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004967737186195218 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4524e+04 |  512 |      1 | 3.525e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 952.9798285538601 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.874927918006189, dt = 0.004967737186195218 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.49 us    (1.4%)
   patch tree reduce : 1785.00 ns (0.6%)
   gen split merge   : 1065.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1133.00 ns (0.4%)
   LB compute        : 297.97 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.37 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.148578604065925e-18,-3.470075789213656e-17,2.862944256665223e-18)
    sum a = (-1.3055962561070445e-16,-4.5104545098872963e-17,-1.4244464982549055e-17)
    sum e = 2.5920007642101504
    sum de = -1.285796013932028e-18
Info: CFL hydro = 0.007026935318152612 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007026935318152612 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5744e+04 |  512 |      1 | 3.252e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 549.9192770791036 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.879895655192384, dt = 0.007026935318152612 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.82 us    (1.5%)
   patch tree reduce : 1305.00 ns (0.4%)
   gen split merge   : 802.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 986.00 ns  (0.3%)
   LB compute        : 295.16 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.65 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.618106228652778e-18,-3.493787290725914e-17,2.6404659708711974e-18)
    sum a = (-4.680240570098526e-17,-7.3897919034005e-17,4.032126195430141e-17)
    sum e = 2.592000813431672
    sum de = -7.678353666860233e-19
Info: CFL hydro = 0.008396285594529207 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008396285594529207 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9351e+04 |  512 |      1 | 2.646e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 956.0868134662416 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.8869225905105367, dt = 0.008396285594529207 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.6%)
   patch tree reduce : 1701.00 ns (0.6%)
   gen split merge   : 739.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1575.00 ns (0.6%)
   LB compute        : 264.30 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.593223788794235e-18,-3.5611162456372634e-17,3.1264053845792004e-18)
    sum a = (1.9308773330228844e-17,-7.577434773392566e-17,-6.342973021822295e-17)
    sum e = 2.5920008490748
    sum de = 5.404070203482436e-19
Info: CFL hydro = 0.009307984273500656 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009307984273500656 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9666e+04 |  512 |      1 | 2.604e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1160.9848423801725 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.895318876105066, dt = 0.009307984273500656 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.49 us    (1.6%)
   patch tree reduce : 1504.00 ns (0.5%)
   gen split merge   : 801.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1066.00 ns (0.4%)
   LB compute        : 265.28 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.56 us    (71.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.379527540597342e-18,-3.650400294541445e-17,2.101834331580399e-18)
    sum a = (-3.6650370238699994e-17,-1.2942527908774148e-16,-8.07947458936198e-17)
    sum e = 2.5920008732237165
    sum de = 4.573977915173222e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010305512811948712
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.634206630914187e-18,-3.67059898101485e-17,1.996449880414808e-18)
    sum a = (-6.961228468660429e-17,-6.948348146851302e-17,-3.409772464380012e-17)
    sum e = 2.5920007077682627
    sum de = 1.3298417271892515e-18
Info: CFL hydro = 0.004959667671932498 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004959667671932498 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5026e+04 |  512 |      1 | 3.407e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 983.4001460453097 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.9046268603785665, dt = 0.004959667671932498 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.5%)
   patch tree reduce : 1180.00 ns (0.4%)
   gen split merge   : 1180.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 949.00 ns  (0.3%)
   LB compute        : 273.94 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.247485589780612e-18,-3.6694280426685654e-17,2.0432874142661817e-18)
    sum a = (-3.8096479096361156e-17,7.953159615256555e-17,-3.19900356204883e-17)
    sum e = 2.5920007540423717
    sum de = -1.6601845766184287e-18
Info: CFL hydro = 0.007020389667170831 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007020389667170831 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0173e+04 |  512 |      1 | 2.538e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 703.4872357705383 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.909586528050499, dt = 0.007020389667170831 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.33 us    (1.1%)
   patch tree reduce : 669.00 ns  (0.2%)
   gen split merge   : 599.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 650.00 ns  (0.2%)
   LB compute        : 282.68 us  (95.9%)
   LB move op cnt    : 0
   LB apply          : 2.18 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.20064805592924e-18,-3.603562760690071e-17,1.8442278953978432e-18)
    sum a = (-4.373454723372028e-18,1.1898197271181799e-17,1.864133847284677e-17)
    sum e = 2.5920008006724835
    sum de = 1.1858461261560205e-18
Info: CFL hydro = 0.008396749330065829 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008396749330065829 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0473e+04 |  512 |      1 | 2.501e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1010.5700027719954 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.9166069177176697, dt = 0.008396749330065829 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.48 us    (1.2%)
   patch tree reduce : 660.00 ns  (0.2%)
   gen split merge   : 552.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 615.00 ns  (0.2%)
   LB compute        : 271.76 us  (95.7%)
   LB move op cnt    : 0
   LB apply          : 2.23 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1902.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.169910924339275e-18,-3.58980423512123e-17,2.1076890233118208e-18)
    sum a = (-2.5696242009209946e-17,-3.9405002698333913e-17,1.0259761790143428e-16)
    sum e = 2.592000844173004
    sum de = 1.5619287547369298e-18
Info: CFL hydro = 0.009319490230665726 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009319490230665726 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0099e+04 |  512 |      1 | 2.547e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1186.658071118503 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.9250036670477355, dt = 0.009319490230665726 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.76 us    (1.2%)
   patch tree reduce : 642.00 ns  (0.2%)
   gen split merge   : 478.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 735.00 ns  (0.2%)
   LB compute        : 305.52 us  (96.1%)
   LB move op cnt    : 0
   LB apply          : 2.02 us    (0.6%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.764893971545008e-18,-3.670891715601421e-17,3.486468926061636e-18)
    sum a = (-1.6483884569817863e-16,1.7565831601784599e-16,-2.903927098785175e-18)
    sum e = 2.5920008860933543
    sum de = 4.472333961502706e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01056965258389137
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.009422038143748e-17,-3.5842422779763796e-17,2.927345865710862e-18)
    sum a = (7.623394103484227e-17,1.5567625313850362e-17,5.669683472708798e-17)
    sum e = 2.59200071313814
    sum de = -2.168404344971009e-18
Info: CFL hydro = 0.004972200043148938 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004972200043148938 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4763e+04 |  512 |      1 | 3.468e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 967.4043104266846 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.9343231572784014, dt = 0.004972200043148938 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.5%)
   patch tree reduce : 807.00 ns  (0.3%)
   gen split merge   : 515.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 980.00 ns  (0.3%)
   LB compute        : 272.24 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.14 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.639329486179182e-18,-3.6310798118277534e-17,3.509887692987323e-18)
    sum a = (2.4156458083846033e-17,-7.977017484062099e-17,7.922568850959876e-17)
    sum e = 2.592000761286849
    sum de = -1.870248747537495e-18
Info: CFL hydro = 0.007042940335426322 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007042940335426322 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0207e+04 |  512 |      1 | 2.534e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 706.4500382031799 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.9392953573215506, dt = 0.007042940335426322 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.3%)
   patch tree reduce : 852.00 ns  (0.3%)
   gen split merge   : 623.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1064.00 ns (0.3%)
   LB compute        : 293.25 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.49 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.469543425967951e-18,-3.7232912065976455e-17,4.0777927909352304e-18)
    sum a = (-5.472965830533027e-17,8.155585581870461e-18,1.401379012833104e-16)
    sum e = 2.5920008202411355
    sum de = 1.463672932855431e-18
Info: CFL hydro = 0.008423976785867919 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008423976785867919 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0014e+04 |  512 |      1 | 2.558e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 991.0870367109161 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.9463382976569767, dt = 0.008423976785867919 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.3%)
   patch tree reduce : 1297.00 ns (0.4%)
   gen split merge   : 605.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 904.00 ns  (0.3%)
   LB compute        : 291.52 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 2.21 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.128196245752896e-18,-3.675868203573129e-17,5.512192265133553e-18)
    sum a = (7.097057316829413e-17,-8.05020113070487e-18,-1.0538445116559103e-17)
    sum e = 2.59200088254547
    sum de = -1.8973538018496328e-19
Info: CFL hydro = 0.00934648829784059 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00934648829784059 cfl multiplier : 0.8356164383561643         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5243e+04 |  512 |      1 | 3.359e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 902.8694678944477 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.9547622744428446, dt = 0.00934648829784059 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 6.12 us    (1.4%)
   patch tree reduce : 946.00 ns  (0.2%)
   gen split merge   : 552.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 1008.00 ns (0.2%)
   LB compute        : 429.55 us  (95.7%)
   LB move op cnt    : 0
   LB apply          : 3.72 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.75 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.249260649573209e-18,-3.705434396816809e-17,4.815483949094368e-18)
    sum a = (-8.272093947325754e-17,1.9882533119908174e-16,-4.135754239076306e-17)
    sum e = 2.5920009466816025
    sum de = 1.0977546996415732e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010198083366701546
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.968655896071653e-18,-3.5789730554180996e-17,4.710099497928777e-18)
    sum a = (-4.58978558284806e-17,5.2212140860818934e-17,8.533798667720305e-17)
    sum e = 2.592000719400496
    sum de = -5.963111948670274e-19
Info: CFL hydro = 0.004984197619911255 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004984197619911255 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.2074e+04 |  512 |      1 | 4.240e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 793.4831142784673 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.9641087627406852, dt = 0.004984197619911255 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.85 us    (1.6%)
   patch tree reduce : 2.08 us    (0.7%)
   gen split merge   : 655.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1034.00 ns (0.3%)
   LB compute        : 277.95 us  (90.3%)
   LB move op cnt    : 0
   LB apply          : 15.08 us   (4.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.11063217055863e-18,-3.642203726117454e-17,5.6966150546733376e-18)
    sum a = (1.789193793122479e-17,-6.25515264585097e-17,1.0819470319667345e-16)
    sum e = 2.5920007826755347
    sum de = 1.6601845766184287e-18
Info: CFL hydro = 0.007058057253058044 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007058057253058044 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0063e+04 |  512 |      1 | 2.552e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 703.1254908262156 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.9690929603605967, dt = 0.007058057253058044 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.90 us    (1.3%)
   patch tree reduce : 1348.00 ns (0.5%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 277.53 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.68 us    (1.3%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.531749525614308e-18,-3.734122386300775e-17,6.60555594597656e-18)
    sum a = (2.3049921346607326e-17,-2.3407057542224052e-17,6.693083587361315e-17)
    sum e = 2.5920008627727418
    sum de = 8.876905287225068e-19
Info: CFL hydro = 0.008445332114796792 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008445332114796792 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9031e+04 |  512 |      1 | 2.690e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 944.4627880304696 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.9761510176136547, dt = 0.008445332114796792 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.79 us    (1.2%)
   patch tree reduce : 1547.00 ns (0.5%)
   gen split merge   : 731.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 967.00 ns  (0.3%)
   LB compute        : 289.46 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.481252809430795e-18,-3.718607453212508e-17,7.018311713041792e-18)
    sum a = (1.1258572199523975e-17,7.399159410170775e-17,1.0772632785815972e-17)
    sum e = 2.592000946693741
    sum de = 4.2012834183813297e-19
Info: CFL hydro = 0.009372248445366589 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009372248445366589 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9840e+04 |  512 |      1 | 2.581e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1178.1079255571574 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 3.9845963497284513, dt = 0.009372248445366589 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.5%)
   patch tree reduce : 1124.00 ns (0.4%)
   gen split merge   : 671.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1486.00 ns (0.5%)
   LB compute        : 276.45 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (68.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.238283102576794e-18,-3.6050264336229265e-17,6.829497904703441e-18)
    sum a = (7.858350201030845e-17,1.0503316966170573e-16,-6.88043372276681e-17)
    sum e = 2.592001028540286
    sum de = -3.2526065174565133e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.0104908003177911
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.877487724627929e-18,-3.6050264336229265e-17,6.545545355729487e-18)
    sum a = (7.643373239017704e-17,-1.8064065868128587e-16,-9.226994168720637e-18)
    sum e = 2.592000724618012
    sum de = 4.743384504624082e-20
Info: CFL hydro = 0.004997609918334763 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004997609918334763 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4651e+04 |  512 |      1 | 3.495e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 965.4659574428066 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.9939685981738178, dt = 0.004997609918334763 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1595.00 ns (0.5%)
   gen split merge   : 1127.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 1033.00 ns (0.3%)
   LB compute        : 285.29 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1958.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.933839132542863e-18,-3.836579491600656e-17,6.750459566329248e-18)
    sum a = (1.2054956642290614e-16,1.3737448678607933e-16,-1.9076927537664546e-16)
    sum e = 2.592000809633699
    sum de = -2.303929616531697e-19
Info: CFL hydro = 0.007076245802947237 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007076245802947237 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9513e+04 |  512 |      1 | 2.624e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 685.6728661957047 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 3.9989662080921526, dt = 0.001033791907847359 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.3%)
   patch tree reduce : 1482.00 ns (0.5%)
   gen split merge   : 677.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 976.00 ns  (0.3%)
   LB compute        : 297.79 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1968.00 ns (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.400330348517059e-18,-3.7370497321664866e-17,6.0274051374986644e-18)
    sum a = (7.179754837535746e-17,3.11820881615521e-17,-1.5194095981385657e-16)
    sum e = 2.59200072257121
    sum de = 8.334804200982315e-19
Info: CFL hydro = 0.008461845202759678 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008461845202759678 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9233e+04 |  512 |      1 | 2.662e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 139.80363853569457 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 541                                                     [SPH][rank=0]
Info: time since start : 1750.1205516 (s)                                             [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14972556747481292 max=0.15026453795865816 delta=0.0005389704838452414
Number of particle pairs: 130816
Distance min=0.146383 max=1.908317 mean=0.806688
---------------- t = 4, dt = 0.008461845202759678 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.01 us    (1.6%)
   patch tree reduce : 1530.00 ns (0.3%)
   gen split merge   : 498.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 771.00 ns  (0.1%)
   LB compute        : 547.21 us  (96.1%)
   LB move op cnt    : 0
   LB apply          : 3.81 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.79 us    (79.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.659711844492211e-18,-3.7209493299050767e-17,4.817679458493651e-18)
    sum a = (4.9706332799770434e-17,-6.824228682145161e-17,7.91554322088217e-18)
    sum e = 2.59200099231465
    sum de = 1.9922214919421144e-18
Info: CFL hydro = 0.009392510086037696 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009392510086037696 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.3322e+04 |  512 |      1 | 3.843e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 792.6313311414834 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.00846184520276, dt = 0.009392510086037696 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.98 us    (0.9%)
   patch tree reduce : 1933.00 ns (0.3%)
   gen split merge   : 923.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 1124.00 ns (0.2%)
   LB compute        : 622.09 us  (96.8%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (0.5%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.643611442230801e-18,-3.8096479096361156e-17,5.575313160362943e-18)
    sum a = (-5.346504489134318e-17,-1.0510342596248279e-16,-5.714179129867603e-18)
    sum e = 2.5920010832949565
    sum de = 1.5178830414797062e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010548492848307868
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.971474179190418e-18,-3.820479089339246e-17,5.5257312397624655e-18)
    sum a = (-9.808950526823956e-17,-1.288266368582036e-16,-5.8265892111109e-17)
    sum e = 2.5920007238597753
    sum de = -9.012430558785756e-19
Info: CFL hydro = 0.005010998331688418 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005010998331688418 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.1320e+04 |  512 |      1 | 4.523e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 747.5744880743216 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.017854355288797, dt = 0.005010998331688418 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 6.15 us    (2.0%)
   patch tree reduce : 1773.00 ns (0.6%)
   gen split merge   : 840.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1040.00 ns (0.3%)
   LB compute        : 291.25 us  (93.6%)
   LB move op cnt    : 0
   LB apply          : 3.67 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.818940807313713e-18,-3.909031301776999e-17,4.910622689729971e-18)
    sum a = (-1.6783937521053228e-16,2.9460808792514116e-17,3.381669944069188e-17)
    sum e = 2.5920008249002655
    sum de = -1.5449880957918438e-18
Info: CFL hydro = 0.007097704180243075 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007097704180243075 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8804e+04 |  512 |      1 | 2.723e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 662.5260547385288 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.022865353620486, dt = 0.007097704180243075 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.94 us    (1.4%)
   patch tree reduce : 1280.00 ns (0.4%)
   gen split merge   : 1003.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1026.00 ns (0.3%)
   LB compute        : 336.78 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.213089275858511e-18,-3.824870108137812e-17,5.368386399480507e-18)
    sum a = (-8.840584514446802e-18,1.5198779734770795e-17,-5.4425214335296344e-17)
    sum e = 2.5920009373983754
    sum de = 8.809142651444724e-19
Info: CFL hydro = 0.008493710155323167 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008493710155323167 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9144e+04 |  512 |      1 | 2.674e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 955.4111673540885 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.029963057800729, dt = 0.008493710155323167 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.80 us    (1.6%)
   patch tree reduce : 1514.00 ns (0.5%)
   gen split merge   : 731.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 921.00 ns  (0.3%)
   LB compute        : 283.76 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.765937194871176e-18,-3.8335057784416595e-17,4.565927714042517e-18)
    sum a = (-1.4728062519564489e-16,-4.224745553393916e-17,-9.222310415335499e-17)
    sum e = 2.5920010406030354
    sum de = 2.0328790734103208e-19
Info: CFL hydro = 0.009417445467200499 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009417445467200499 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9079e+04 |  512 |      1 | 2.684e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1139.4346886560327 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.038456767956053, dt = 0.009417445467200499 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.08 us    (1.7%)
   patch tree reduce : 1632.00 ns (0.5%)
   gen split merge   : 740.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 281.99 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1860.00 ns (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0928513953165075e-17,-3.8895644517700226e-17,3.5259880952487336e-18)
    sum a = (-4.3558906481777625e-17,6.978792543854694e-18,3.7470027081099036e-17)
    sum e = 2.5920011226708852
    sum de = -6.911788849595091e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011716417768171247
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0034941627656835e-17,-3.876537762667609e-17,4.1480490917122915e-18)
    sum a = (5.971200096877016e-17,-2.7563888671533476e-17,-1.3770234952303894e-17)
    sum e = 2.5920007244627996
    sum de = 1.9109063290057016e-18
Info: CFL hydro = 0.00501814933755029 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00501814933755029 cfl multiplier : 0.44520547945205474        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4272e+04 |  512 |      1 | 3.587e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 945.0528090841165 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.0478742134232535, dt = 0.00501814933755029 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.05 us    (1.7%)
   patch tree reduce : 1600.00 ns (0.5%)
   gen split merge   : 819.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1024.00 ns (0.3%)
   LB compute        : 283.56 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.461913674443933e-18,-3.9160569318547056e-17,3.8743422532683255e-18)
    sum a = (2.575713080321673e-16,2.435551760271437e-17,2.5245430745890472e-17)
    sum e = 2.5920008365842766
    sum de = -9.0801931945661e-19
Info: CFL hydro = 0.007103222328933118 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007103222328933118 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9505e+04 |  512 |      1 | 2.625e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 688.220458024386 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 4.052892362760804, dt = 0.007103222328933118 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.96 us    (1.5%)
   patch tree reduce : 1450.00 ns (0.4%)
   gen split merge   : 674.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1560.00 ns (0.5%)
   LB compute        : 321.92 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 4.34 us    (1.3%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.37 us    (71.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.21737123191013e-18,-3.8780014356004644e-17,4.1626858210408455e-18)
    sum a = (-9.362237547716479e-17,-6.1591357014556536e-18,1.0440086295471218e-16)
    sum e = 2.5920009504492016
    sum de = -2.3987973066241786e-18
Info: CFL hydro = 0.00849546300525737 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00849546300525737 cfl multiplier : 0.7534246575342465         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8806e+04 |  512 |      1 | 2.723e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 939.247540631547 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 4.0599955850897365, dt = 0.00849546300525737 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.4%)
   patch tree reduce : 1233.00 ns (0.4%)
   gen split merge   : 785.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 998.00 ns  (0.3%)
   LB compute        : 302.11 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.178692961936408e-18,-3.883270658158744e-17,5.336551513190901e-18)
    sum a = (-8.467055181982097e-17,1.434867849536836e-16,8.346448532314809e-17)
    sum e = 2.5920010456740132
    sum de = 4.743384504624082e-20
Info: CFL hydro = 0.009427852994282037 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009427852994282037 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8231e+04 |  512 |      1 | 2.808e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1089.032387847262 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.068491048094994, dt = 0.009427852994282037 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.37 us    (1.8%)
   patch tree reduce : 1480.00 ns (0.5%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1024.00 ns (0.3%)
   LB compute        : 285.01 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.91492044716269e-18,-3.686406648689689e-17,5.939584761527339e-18)
    sum a = (6.786758655064062e-17,-9.313643606345679e-17,6.6040922730437045e-18)
    sum e = 2.592001112215148
    sum de = -6.437450399132683e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.012079582142304217
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.166983578473564e-18,-3.7873268974100706e-17,5.6234314080305656e-18)
    sum a = (-1.3969294471172233e-17,-6.526810342188937e-17,-4.4261469489548234e-17)
    sum e = 2.592000722929379
    sum de = -4.811147140404426e-19
Info: CFL hydro = 0.005028180805385799 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005028180805385799 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4196e+04 |  512 |      1 | 3.607e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 941.0776095415117 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.077918901089276, dt = 0.005028180805385799 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.43 us    (1.7%)
   patch tree reduce : 1667.00 ns (0.5%)
   gen split merge   : 770.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1084.00 ns (0.3%)
   LB compute        : 307.35 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.685123796704386e-18,-3.8241382716713844e-17,5.1374919943225625e-18)
    sum a = (6.903852489692497e-17,8.814823870828548e-17,7.868705687030797e-17)
    sum e = 2.592000833065656
    sum de = -6.030874584450618e-19
Info: CFL hydro = 0.007113085244612352 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007113085244612352 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9330e+04 |  512 |      1 | 2.649e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 683.3994585489676 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.082947081894662, dt = 0.007113085244612352 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.3%)
   patch tree reduce : 1779.00 ns (0.5%)
   gen split merge   : 823.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 959.00 ns  (0.3%)
   LB compute        : 334.60 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.34 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.095263604763648e-18,-3.690065831021827e-17,5.97764025778158e-18)
    sum a = (4.567245019682087e-17,4.0748654450695194e-18,-7.053732598016893e-17)
    sum e = 2.5920009356218503
    sum de = 6.301925127571995e-19
Info: CFL hydro = 0.008493949121213287 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008493949121213287 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9121e+04 |  512 |      1 | 2.678e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 956.3092763294841 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.090060167139274, dt = 0.008493949121213287 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.76 us    (1.5%)
   patch tree reduce : 1428.00 ns (0.5%)
   gen split merge   : 940.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1029.00 ns (0.3%)
   LB compute        : 295.26 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.730809044482646e-18,-3.750991216851934e-17,4.827193332557211e-18)
    sum a = (-1.37175427267211e-16,-1.1433042013120342e-16,8.604054968497365e-17)
    sum e = 2.592001013278144
    sum de = -8.470329472543003e-20
Info: CFL hydro = 0.00940772184254489 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00940772184254489 cfl multiplier : 0.8356164383561643         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8940e+04 |  512 |      1 | 2.703e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1131.1334120697354 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.0985541162604875, dt = 0.00940772184254489 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 2.22 us    (0.7%)
   gen split merge   : 762.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1013.00 ns (0.3%)
   LB compute        : 287.51 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1966.00 ns (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0714085868501754e-17,-3.9253146631550163e-17,6.387468678981101e-18)
    sum a = (6.491096722627265e-17,3.64630201032945e-17,3.084251604112964e-17)
    sum e = 2.5920010590837994
    sum de = -1.3010426069826053e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011297845229796157
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.856373529848473e-18,-3.810050419692651e-17,6.08009736308146e-18)
    sum a = (8.762131645245752e-17,-1.0812444689589639e-16,3.784472735191002e-17)
    sum e = 2.5920007208321847
    sum de = 3.3881317890172014e-19
Info: CFL hydro = 0.005006356624970145 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005006356624970145 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4478e+04 |  512 |      1 | 3.536e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 957.6836267945005 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.107961838103033, dt = 0.005006356624970145 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.83 us    (1.6%)
   patch tree reduce : 1438.00 ns (0.5%)
   gen split merge   : 718.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1100.00 ns (0.4%)
   LB compute        : 284.08 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1952.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.222603149922071e-18,-3.973689053585888e-17,6.287938919546932e-18)
    sum a = (9.749818140336596e-17,1.4744455656412469e-16,3.161533534967731e-18)
    sum e = 2.592000816281615
    sum de = 1.0503208545953324e-19
Info: CFL hydro = 0.007081545643006534 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007081545643006534 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9202e+04 |  512 |      1 | 2.666e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 675.9109837121212 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.112968194728003, dt = 0.007081545643006534 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.80 us    (1.6%)
   patch tree reduce : 1372.00 ns (0.5%)
   gen split merge   : 769.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1127.00 ns (0.4%)
   LB compute        : 283.62 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.55 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.60786051812279e-18,-3.8078777801829435e-17,6.337703799264016e-18)
    sum a = (-3.970651932250213e-17,2.0374327225347598e-17,5.948366799124471e-18)
    sum e = 2.5920008995478887
    sum de = 4.336808689942018e-19
Info: CFL hydro = 0.008460738045227024 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008460738045227024 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9402e+04 |  512 |      1 | 2.639e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 966.0816449127916 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.12004974037101, dt = 0.008460738045227024 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.86 us    (1.6%)
   patch tree reduce : 1427.00 ns (0.5%)
   gen split merge   : 829.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 989.00 ns  (0.3%)
   LB compute        : 291.81 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1996.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.25480395444489e-18,-3.808330603996546e-17,6.35234052859257e-18)
    sum a = (-1.6177976926851078e-16,2.3629535828018077e-17,6.5221265888038e-18)
    sum e = 2.5920009589765414
    sum de = -1.2993485410880967e-18
Info: CFL hydro = 0.009377141477557473 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009377141477557473 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9031e+04 |  512 |      1 | 2.690e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1132.1231878239607 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.128510478416237, dt = 0.009377141477557473 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.84 us    (1.6%)
   patch tree reduce : 1280.00 ns (0.4%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1038.00 ns (0.3%)
   LB compute        : 281.51 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1943.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1472268447720868e-17,-3.802073402208589e-17,6.45479763389245e-18)
    sum a = (7.02065358973436e-17,6.667322943743059e-17,6.438989966217611e-17)
    sum e = 2.5920009911808717
    sum de = -7.640237184233789e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011162688533859655
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.030572112023509e-17,-3.781362430208684e-17,6.659711844492211e-18)
    sum a = (-9.875108543389022e-17,1.508168590014236e-17,-3.5608235110506925e-17)
    sum e = 2.5920007198696955
    sum de = 5.031375706690544e-19
Info: CFL hydro = 0.004993998267795068 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004993998267795068 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4394e+04 |  512 |      1 | 3.557e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 949.0704612645551 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.137887619893794, dt = 0.004993998267795068 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.5%)
   patch tree reduce : 1762.00 ns (0.6%)
   gen split merge   : 781.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1013.00 ns (0.3%)
   LB compute        : 284.95 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.42 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1997.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1621563086872122e-17,-3.796913955120274e-17,6.0742426713500384e-18)
    sum a = (-2.0198686473404947e-19,-1.3529021652969318e-16,-1.593061620119851e-17)
    sum e = 2.5920007964949052
    sum de = -1.3713463416047122e-18
Info: CFL hydro = 0.007065968034254247 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007065968034254247 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9057e+04 |  512 |      1 | 2.687e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 669.1615607173117 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.1428816181615895, dt = 0.007065968034254247 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.75 us    (1.6%)
   patch tree reduce : 1235.00 ns (0.4%)
   gen split merge   : 736.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1371.00 ns (0.5%)
   LB compute        : 278.26 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.69 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1369811342420987e-17,-3.9291933964270833e-17,6.0274051374986644e-18)
    sum a = (-1.0047529214879392e-16,-1.2996244705409943e-16,-2.2634238233676386e-17)
    sum e = 2.5920008623323105
    sum de = 9.605353621863766e-19
Info: CFL hydro = 0.008438819845113223 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008438819845113223 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9360e+04 |  512 |      1 | 2.645e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 961.8513704718009 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.149947586195844, dt = 0.008438819845113223 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.6%)
   patch tree reduce : 1431.00 ns (0.5%)
   gen split merge   : 677.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1064.00 ns (0.4%)
   LB compute        : 277.99 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.49 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2641743121072357e-17,-4.03446807212271e-17,5.73759789679329e-18)
    sum a = (8.026892139249148e-17,1.1522033327437953e-17,6.262763745101818e-17)
    sum e = 2.592000909704562
    sum de = -4.730679010415267e-19
Info: CFL hydro = 0.009349488427477562 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009349488427477562 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9502e+04 |  512 |      1 | 2.625e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1157.174467738531 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.158386406040957, dt = 0.009349488427477562 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.4%)
   patch tree reduce : 1704.00 ns (0.5%)
   gen split merge   : 648.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1014.00 ns (0.3%)
   LB compute        : 294.02 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.100682045507284e-17,-3.965089975105362e-17,6.747532220463537e-18)
    sum a = (1.5646956386811127e-16,-7.962380754733545e-19,-4.085989359359221e-17)
    sum e = 2.592000938121364
    sum de = 8.402566836762659e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011208150791507651
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.066432098878467e-17,-3.961723527359795e-17,6.305502994741197e-18)
    sum a = (-7.901345593433473e-17,-7.837090351681119e-17,-2.091354433381154e-16)
    sum e = 2.5920007209313933
    sum de = 2.0709955560367643e-18
Info: CFL hydro = 0.0049782885289175495 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0049782885289175495 cfl multiplier : 0.44520547945205474      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4501e+04 |  512 |      1 | 3.531e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 953.2987311403549 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.167735894468435, dt = 0.0049782885289175495 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.18 us    (1.8%)
   patch tree reduce : 1405.00 ns (0.5%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 982.00 ns  (0.3%)
   LB compute        : 277.78 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2212886951745717e-17,-4.050495290737477e-17,4.317835151923522e-18)
    sum a = (-9.802363998626106e-17,1.9133132578286195e-17,2.395154387324627e-17)
    sum e = 2.5920007820042112
    sum de = 1.1570470059493743e-18
Info: CFL hydro = 0.007044091553224579 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007044091553224579 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9542e+04 |  512 |      1 | 2.620e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 684.0393841110434 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.172714182997352, dt = 0.007044091553224579 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1767.00 ns (0.6%)
   gen split merge   : 899.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1043.00 ns (0.3%)
   LB compute        : 282.74 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.52 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2832020602343564e-17,-3.9990471871476083e-17,5.1433466860539845e-18)
    sum a = (1.3817072486155268e-18,5.254000359777855e-17,7.917885097574739e-17)
    sum e = 2.5920008381694073
    sum de = -9.808641529204798e-19
Info: CFL hydro = 0.008420521477043303 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008420521477043303 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9489e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 965.2765692690286 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.179758274550577, dt = 0.008420521477043303 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.3%)
   patch tree reduce : 1445.00 ns (0.5%)
   gen split merge   : 834.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 998.00 ns  (0.3%)
   LB compute        : 298.67 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2466102369129706e-17,-3.949648225663738e-17,5.957148836721604e-18)
    sum a = (9.619258514725892e-18,7.334757801125135e-17,3.4858834568884946e-17)
    sum e = 2.592000883827044
    sum de = -1.4501204056993622e-18
Info: CFL hydro = 0.009339687764850748 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009339687764850748 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9525e+04 |  512 |      1 | 2.622e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1156.0208634259163 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.1881787960276196, dt = 0.009339687764850748 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.5%)
   patch tree reduce : 1503.00 ns (0.5%)
   gen split merge   : 968.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1086.00 ns (0.4%)
   LB compute        : 276.78 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2293388963052765e-17,-3.864901562851408e-17,6.1679177390527865e-18)
    sum a = (-7.075980426596296e-17,5.617576716299144e-17,6.189580098459047e-17)
    sum e = 2.5920009191444
    sum de = -9.181837148236616e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011014189612719223
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2707608403050851e-17,-3.8859052694378836e-17,6.194263851844184e-18)
    sum a = (1.3317667281464995e-16,-2.0163558323016417e-17,-1.2177758801357185e-17)
    sum e = 2.592000723973545
    sum de = 1.1316360175317453e-18
Info: CFL hydro = 0.004979255144662132 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004979255144662132 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4324e+04 |  512 |      1 | 3.575e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 940.6224786147739 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.197518483792471, dt = 0.004979255144662132 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.72 us    (1.6%)
   patch tree reduce : 1202.00 ns (0.4%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1090.00 ns (0.4%)
   LB compute        : 288.24 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1107813887439865e-17,-3.9241071329854105e-17,5.848837039690302e-18)
    sum a = (1.3570589964262413e-16,1.0289620717973679e-16,1.711911862267712e-17)
    sum e = 2.5920007786714265
    sum de = -4.811147140404426e-19
Info: CFL hydro = 0.0070500953508855265 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070500953508855265 cfl multiplier : 0.6301369863013698       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9568e+04 |  512 |      1 | 2.616e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 685.0896721837735 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.202497738937133, dt = 0.0070500953508855265 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.4%)
   patch tree reduce : 1489.00 ns (0.5%)
   gen split merge   : 864.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1041.00 ns (0.3%)
   LB compute        : 293.78 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0214973398398052e-17,-3.816819907007107e-17,6.062533287887195e-18)
    sum a = (3.0684439364381256e-17,-2.0151848939553573e-17,3.803207748731552e-17)
    sum e = 2.5920008360038302
    sum de = -2.7647155398380363e-18
Info: CFL hydro = 0.008435482656674822 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008435482656674822 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8982e+04 |  512 |      1 | 2.697e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 940.9344109810934 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.209547834288019, dt = 0.008435482656674822 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.83 us    (0.8%)
   patch tree reduce : 1238.00 ns (0.2%)
   gen split merge   : 1022.00 ns (0.2%)
   split / merge op  : 0/0
   apply split merge : 1053.00 ns (0.2%)
   LB compute        : 608.08 us  (96.9%)
   LB move op cnt    : 0
   LB apply          : 3.73 us    (0.6%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.12 us    (75.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0223755435995185e-17,-3.882831556278887e-17,6.434306212832474e-18)
    sum a = (-5.494628189939288e-17,-3.485590722301923e-17,-3.379328067376619e-17)
    sum e = 2.5920008893622493
    sum de = 1.1689054672109345e-18
Info: CFL hydro = 0.009363575106437982 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009363575106437982 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8622e+04 |  512 |      1 | 2.749e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1104.536775032065 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.217983316944694, dt = 0.009363575106437982 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 1358.00 ns (0.4%)
   gen split merge   : 802.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1053.00 ns (0.3%)
   LB compute        : 287.87 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1935.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1295164022845361e-17,-3.9181060739607034e-17,5.828345618630326e-18)
    sum a = (-6.922587503233046e-17,-8.442465476710125e-17,9.842907738866202e-17)
    sum e = 2.59200093766001
    sum de = -2.541098841762901e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010487311226521162
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1315655443905337e-17,-3.949135940137238e-17,6.372831949652546e-18)
    sum a = (2.8025238379969506e-16,1.0556009191753368e-16,-9.57827567260594e-17)
    sum e = 2.5920007281846615
    sum de = -2.5173819192397806e-18
Info: CFL hydro = 0.004990657619362396 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004990657619362396 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4177e+04 |  512 |      1 | 3.612e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 933.3614721715427 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.2273468920511315, dt = 0.004990657619362396 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.3%)
   patch tree reduce : 1468.00 ns (0.5%)
   gen split merge   : 844.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1031.00 ns (0.3%)
   LB compute        : 305.51 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.62 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.259506360103197e-18,-3.8055496254241206e-17,5.035034889022682e-18)
    sum a = (-2.845380181470958e-17,1.2858366715134961e-17,1.5318215446091798e-16)
    sum e = 2.5920007866749533
    sum de = 4.0657581468206416e-20
Info: CFL hydro = 0.007065236806903013 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007065236806903013 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8866e+04 |  512 |      1 | 2.714e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 662.0217060894737 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.232337549670494, dt = 0.007065236806903013 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.5%)
   patch tree reduce : 1662.00 ns (0.6%)
   gen split merge   : 700.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1039.00 ns (0.3%)
   LB compute        : 283.41 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.317741890557674e-18,-3.826187413777382e-17,6.727040799403561e-18)
    sum a = (4.7399584257590274e-17,4.318274253803378e-17,-5.374607009445142e-17)
    sum e = 2.5920008535800396
    sum de = -1.3755815063409838e-18
Info: CFL hydro = 0.008451617565013395 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008451617565013395 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9192e+04 |  512 |      1 | 2.668e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 953.4076698821642 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.239402786477397, dt = 0.008451617565013395 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.4%)
   patch tree reduce : 1412.00 ns (0.5%)
   gen split merge   : 883.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1028.00 ns (0.3%)
   LB compute        : 281.89 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1918.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.523699324483602e-18,-3.784472735191002e-17,5.556102453119216e-18)
    sum a = (-3.2434992192076353e-17,1.0320065114977072e-16,-6.96942503708442e-17)
    sum e = 2.592000919179772
    sum de = -1.8126505071242027e-18
Info: CFL hydro = 0.009373588246297011 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009373588246297011 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9402e+04 |  512 |      1 | 2.639e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1152.9742343301766 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.24785440404241, dt = 0.009373588246297011 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.5%)
   patch tree reduce : 1883.00 ns (0.6%)
   gen split merge   : 977.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1083.00 ns (0.4%)
   LB compute        : 287.01 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 3.39 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1921.00 ns (64.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.221871313455642e-18,-3.65449857875344e-17,4.897449633334272e-18)
    sum a = (1.3635577042481196e-16,1.7113263930945697e-17,-1.3826439992925542e-16)
    sum e = 2.592000979686963
    sum de = 7.860465750519907e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010717464867802059
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.422705892116577e-18,-3.7011897453115285e-17,4.55202282118039e-18)
    sum a = (-1.799732238239038e-17,4.5245057700427084e-17,-3.1427985214271816e-17)
    sum e = 2.592000732318823
    sum de = 1.6872896309305663e-18
Info: CFL hydro = 0.004991407838358455 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004991407838358455 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4555e+04 |  512 |      1 | 3.518e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 959.3229772064715 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.2572279922887075, dt = 0.004991407838358455 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.4%)
   patch tree reduce : 2.36 us    (0.7%)
   gen split merge   : 984.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1078.00 ns (0.3%)
   LB compute        : 306.52 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.54 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.220407640522788e-18,-3.665768860336427e-17,4.89159494160285e-18)
    sum a = (-4.8956932258148456e-17,3.7235839411842164e-17,-1.1957622392255729e-16)
    sum e = 2.592000801331939
    sum de = -1.3586408473958977e-18
Info: CFL hydro = 0.007062825789547787 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007062825789547787 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9668e+04 |  512 |      1 | 2.603e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 690.2777014831075 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.262219400127066, dt = 0.007062825789547787 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.5%)
   patch tree reduce : 1440.00 ns (0.5%)
   gen split merge   : 947.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1026.00 ns (0.4%)
   LB compute        : 275.63 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1944.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.720251947092917e-18,-3.634446259573321e-17,3.745539035177048e-18)
    sum a = (1.1690648449302898e-16,1.0317723238284503e-16,-5.311376338745788e-17)
    sum e = 2.592000880532303
    sum de = 1.0672615135404184e-18
Info: CFL hydro = 0.008442675040221913 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008442675040221913 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9026e+04 |  512 |      1 | 2.691e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 944.8544408738306 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.269282225916614, dt = 0.008442675040221913 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1470.00 ns (0.5%)
   gen split merge   : 641.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1014.00 ns (0.3%)
   LB compute        : 277.62 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1964.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.187054549926853e-18,-3.5367460913052205e-17,3.61673581708577e-18)
    sum a = (-9.888574334371291e-17,2.761072620538485e-17,-7.208296459726426e-17)
    sum e = 2.5920009566157516
    sum de = 2.6156377411212794e-18
Info: CFL hydro = 0.009363063581547268 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009363063581547268 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8914e+04 |  512 |      1 | 2.707e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1122.7719626162288 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.277724900956835, dt = 0.009363063581547268 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.5%)
   patch tree reduce : 1268.00 ns (0.4%)
   gen split merge   : 706.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 981.00 ns  (0.3%)
   LB compute        : 283.53 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.46 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0074460796843932e-17,-3.535062867432437e-17,2.809520194616e-18)
    sum a = (-1.938020056935219e-16,1.8642509411193054e-16,-4.6228645911305934e-17)
    sum e = 2.592001023654884
    sum de = 9.317362419797304e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01075520117754002
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0458309023485268e-17,-3.477613704817861e-17,3.048098882671435e-18)
    sum a = (2.228764048317622e-16,-8.515063654179755e-17,2.754046990460779e-17)
    sum e = 2.5920007352536434
    sum de = -6.437450399132683e-20
Info: CFL hydro = 0.004990127851297283 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004990127851297283 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4082e+04 |  512 |      1 | 3.636e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 927.0427801691333 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.287087964538383, dt = 0.004990127851297283 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.3%)
   patch tree reduce : 1694.00 ns (0.5%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1074.00 ns (0.3%)
   LB compute        : 294.28 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.269331621026497e-18,-3.629762506188183e-17,3.429019763447061e-18)
    sum a = (1.0024403182540275e-16,6.63804948508595e-17,2.3400031912146346e-16)
    sum e = 2.5920008161152444
    sum de = -9.012430558785756e-19
Info: CFL hydro = 0.007064243704946992 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007064243704946992 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9091e+04 |  512 |      1 | 2.682e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 669.8359490098852 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.29207809238968, dt = 0.007064243704946992 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.3%)
   patch tree reduce : 1471.00 ns (0.5%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1533.00 ns (0.5%)
   LB compute        : 296.13 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1979.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.958118163678112e-18,-3.5429667012698563e-17,5.64941160258875e-18)
    sum a = (-1.9823986202593957e-17,-9.020909019774593e-17,7.025630077706068e-19)
    sum e = 2.5920009049543213
    sum de = 1.497554250745603e-18
Info: CFL hydro = 0.00844193387153864 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00844193387153864 cfl multiplier : 0.7534246575342465         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9262e+04 |  512 |      1 | 2.658e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 956.7706004620624 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.299142336094627, dt = 0.00844193387153864 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.4%)
   patch tree reduce : 1495.00 ns (0.5%)
   gen split merge   : 692.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1132.00 ns (0.4%)
   LB compute        : 301.35 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.73 us    (73.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.567737940212399e-18,-3.677770978385841e-17,4.813928796603209e-18)
    sum a = (7.016262570935794e-17,1.2997415643756227e-18,5.016299875482133e-17)
    sum e = 2.5920009857994035
    sum de = -1.1384122811097797e-18
Info: CFL hydro = 0.009357913801838551 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009357913801838551 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9451e+04 |  512 |      1 | 2.632e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1154.561482348442 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.307584269966165, dt = 0.009357913801838551 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.5%)
   patch tree reduce : 1496.00 ns (0.5%)
   gen split merge   : 750.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1006.00 ns (0.3%)
   LB compute        : 275.61 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.527020745173036e-18,-3.650473478188088e-17,5.461695548950041e-18)
    sum a = (1.1826477297471882e-18,5.1170005732625865e-17,-1.442596042622313e-17)
    sum e = 2.5920010513260086
    sum de = 1.0994487655360818e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011879648138579639
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.8090979632017685e-18,-3.6141377976299515e-17,5.186159119340006e-18)
    sum a = (8.557217434645992e-17,-1.2303049204409612e-16,-1.4753823163182746e-17)
    sum e = 2.592000736602219
    sum de = 1.4941661189565858e-18
Info: CFL hydro = 0.0049857953922450085 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0049857953922450085 cfl multiplier : 0.44520547945205474      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4414e+04 |  512 |      1 | 3.552e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 948.4317358702965 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.3169421837680035, dt = 0.0049857953922450085 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1440.00 ns (0.5%)
   gen split merge   : 679.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1021.00 ns (0.3%)
   LB compute        : 291.35 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1931.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.976359543965332e-18,-3.75615066394025e-17,5.0994364980683214e-18)
    sum a = (1.1584093059791023e-16,8.821849500906254e-17,4.604129577590044e-17)
    sum e = 2.5920008250640194
    sum de = 9.825582188149884e-19
Info: CFL hydro = 0.007057008973969215 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007057008973969215 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8388e+04 |  512 |      1 | 2.784e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 644.6050560736696 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.3219279791602485, dt = 0.007057008973969215 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.4%)
   patch tree reduce : 1492.00 ns (0.5%)
   gen split merge   : 762.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1066.00 ns (0.3%)
   LB compute        : 293.14 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.34 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.1063889444993844e-18,-3.6325434847606087e-17,5.6000126411048785e-18)
    sum a = (1.0386223131542139e-16,1.5784248907912968e-17,-4.962436711553053e-17)
    sum e = 2.592000916466126
    sum de = 1.2349740370967699e-18
Info: CFL hydro = 0.008439887640608374 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008439887640608374 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9735e+04 |  512 |      1 | 2.594e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 979.2349096689272 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.328984988134218, dt = 0.008439887640608374 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.3%)
   patch tree reduce : 2.15 us    (0.7%)
   gen split merge   : 790.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1071.00 ns (0.3%)
   LB compute        : 306.28 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1997.00 ns (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.291489039132124e-18,-3.647216805912484e-17,4.8286570054900665e-18)
    sum a = (-5.099436498068321e-17,1.0226975516447467e-16,9.674292617001256e-17)
    sum e = 2.592000995082927
    sum de = 3.049318610115481e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010069395034733294
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.863419237645383e-18,-3.6274023335839537e-17,5.41705352449795e-18)
    sum a = (-1.3211697361126263e-16,7.168484555952759e-17,-6.868724339303967e-17)
    sum e = 2.592000736054222
    sum de = -5.742883382384156e-19
Info: CFL hydro = 0.004683950108838443 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004683950108838443 cfl multiplier : 0.41780821917808214       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4520e+04 |  512 |      1 | 3.526e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 861.66930873628 (tsim/hr)                               [sph::Model][rank=0]
---------------- t = 4.337424875774826, dt = 0.004683950108838443 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.16 us    (1.5%)
   patch tree reduce : 1444.00 ns (0.4%)
   gen split merge   : 659.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1027.00 ns (0.3%)
   LB compute        : 319.61 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.85 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.15 us    (74.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.874817234248486e-18,-3.6178884595203934e-17,4.357354321110618e-18)
    sum a = (4.065497938299245e-17,2.929687742403431e-17,1.915655134521188e-17)
    sum e = 2.5920008153425154
    sum de = -1.1011428314305904e-19
Info: CFL hydro = 0.006862723308362826 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006862723308362826 cfl multiplier : 0.6118721461187214        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6999e+04 |  512 |      1 | 3.012e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 559.8358639214371 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.342108825883665, dt = 0.006862723308362826 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1290.00 ns (0.4%)
   gen split merge   : 1015.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 975.00 ns  (0.3%)
   LB compute        : 278.25 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1951.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.21213931389819e-18,-3.6013032155999756e-17,4.780355798705838e-18)
    sum a = (2.8570895649338013e-18,-5.721204759945309e-17,-7.189561446185877e-18)
    sum e = 2.592000905265384
    sum de = 1.789568859311523e-18
Info: CFL hydro = 0.008313519541504732 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008313519541504732 cfl multiplier : 0.741248097412481         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9393e+04 |  512 |      1 | 2.640e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 935.7869145643997 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.3489715491920276, dt = 0.008313519541504732 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.99 us    (1.6%)
   patch tree reduce : 1972.00 ns (0.6%)
   gen split merge   : 914.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 967.00 ns  (0.3%)
   LB compute        : 291.40 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.372411500045859e-18,-3.682527915417622e-17,4.666189309943114e-18)
    sum a = (7.367544074821097e-17,6.22002449546244e-17,4.5245057700427084e-17)
    sum e = 2.5920009811982254
    sum de = 1.6843250156151762e-18
Info: CFL hydro = 0.009280151627022818 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009280151627022818 cfl multiplier : 0.8274987316083205        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9188e+04 |  512 |      1 | 2.668e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1121.6295595317952 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.357285068733533, dt = 0.009280151627022818 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1951.00 ns (0.6%)
   gen split merge   : 802.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1094.00 ns (0.4%)
   LB compute        : 284.11 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.218305392489352e-18,-3.5561763494888764e-17,5.2282397161596e-18)
    sum a = (-1.4217533400584515e-16,-4.421463195569686e-17,1.8524244638218334e-17)
    sum e = 2.5920010350969247
    sum de = -9.84252284709497e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011438684627966449
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.534879195592812e-18,-3.609710187008064e-17,5.1140732273968755e-18)
    sum a = (1.3336987764178686e-16,-2.857089564933801e-17,5.1287099567254304e-18)
    sum e = 2.592000735848184
    sum de = -6.496742705440484e-19
Info: CFL hydro = 0.004964593154834879 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004964593154834879 cfl multiplier : 0.4424995772027735        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4618e+04 |  512 |      1 | 3.503e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 953.8115525305426 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.366565220360555, dt = 0.004964593154834879 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1586.00 ns (0.5%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1102.00 ns (0.4%)
   LB compute        : 283.66 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.3708387643660574e-18,-3.60934426877485e-17,5.087727114605478e-18)
    sum a = (-7.318364664277155e-17,-1.1060683619001921e-16,3.470661258386798e-17)
    sum e = 2.592000820927953
    sum de = -1.6940658945086007e-20
Info: CFL hydro = 0.007051257268164876 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007051257268164876 cfl multiplier : 0.6283330514685157        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0021e+04 |  512 |      1 | 2.557e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 698.875937455041 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 4.37152981351539, dt = 0.007051257268164876 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.98 us    (1.7%)
   patch tree reduce : 1167.00 ns (0.4%)
   gen split merge   : 951.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 878.00 ns  (0.3%)
   LB compute        : 274.77 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.41 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1861.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.38882328916701e-18,-3.714655536293798e-17,5.441935964356492e-18)
    sum a = (3.0011149815267754e-17,-8.484619257176362e-17,-6.063118757060338e-17)
    sum e = 2.592000902739765
    sum de = 1.1841520602615119e-18
Info: CFL hydro = 0.008446025794584693 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008446025794584693 cfl multiplier : 0.7522220343123438        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9688e+04 |  512 |      1 | 2.601e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 976.1273728064624 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.378581070783555, dt = 0.008446025794584693 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1606.00 ns (0.5%)
   gen split merge   : 699.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 988.00 ns  (0.3%)
   LB compute        : 290.09 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.681869262597836e-18,-3.774666126540871e-17,4.540313437717547e-18)
    sum a = (-1.7593348652922282e-17,-1.6229205479501017e-17,4.0163185277553026e-17)
    sum e = 2.5920009678731173
    sum de = -5.505714157152952e-19
Info: CFL hydro = 0.009381783088438504 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009381783088438504 cfl multiplier : 0.8348146895415626        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9303e+04 |  512 |      1 | 2.652e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1146.3258205055236 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.387027096578139, dt = 0.009381783088438504 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1515.00 ns (0.5%)
   gen split merge   : 803.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 983.00 ns  (0.3%)
   LB compute        : 275.97 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.069010753338098e-18,-3.7675673128165223e-17,5.324842129728058e-18)
    sum a = (1.8708081958584978e-16,-2.110030900004389e-17,3.2235932673208013e-17)
    sum e = 2.592001011546986
    sum de = -1.1079190950086248e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010426530847362224
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.999065839420778e-18,-3.770860576915447e-17,5.403880468102251e-18)
    sum a = (1.6125577435854853e-16,5.618162185472286e-17,1.016023203070926e-16)
    sum e = 2.5920007357088837
    sum de = -2.507217523872729e-19
Info: CFL hydro = 0.005007583445533052 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005007583445533052 cfl multiplier : 0.44493822984718756       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4126e+04 |  512 |      1 | 3.625e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 931.8056897317748 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.396408879666578, dt = 0.005007583445533052 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.5%)
   patch tree reduce : 1532.00 ns (0.5%)
   gen split merge   : 716.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1041.00 ns (0.4%)
   LB compute        : 276.01 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.587773745288402e-18,-3.7158264746400824e-17,6.238174039829847e-18)
    sum a = (-1.6812332775950622e-16,6.620485409891685e-17,8.200081239029266e-17)
    sum e = 2.592000813775459
    sum de = -2.1955093992831465e-18
Info: CFL hydro = 0.0070892751585173676 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070892751585173676 cfl multiplier : 0.6299588198981251       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9447e+04 |  512 |      1 | 2.633e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 684.7281058605735 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.401416463112111, dt = 0.0070892751585173676 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 15.32 us   (4.9%)
   patch tree reduce : 1461.00 ns (0.5%)
   gen split merge   : 797.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 970.00 ns  (0.3%)
   LB compute        : 283.13 us  (91.1%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1815.00 ns (64.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.402728182029136e-18,-3.657865026499007e-17,6.68898530314932e-18)
    sum a = (1.1399084801078097e-17,-8.388602312781046e-17,1.6322880547203766e-17)
    sum e = 2.5920008864792163
    sum de = 7.047314121155779e-19
Info: CFL hydro = 0.008470408716165643 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008470408716165643 cfl multiplier : 0.7533058799320834        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9068e+04 |  512 |      1 | 2.685e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 950.4817629977917 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.408505738270628, dt = 0.008470408716165643 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.6%)
   patch tree reduce : 1361.00 ns (0.5%)
   gen split merge   : 1024.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 1072.00 ns (0.4%)
   LB compute        : 265.57 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1839.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.654791313340011e-18,-3.7875464483499986e-17,6.542618009863776e-18)
    sum a = (2.1826290774740188e-17,-5.3535301192120245e-17,7.646227401236772e-18)
    sum e = 2.59200094338601
    sum de = -1.8973538018496328e-19
Info: CFL hydro = 0.009384049212575274 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009384049212575274 cfl multiplier : 0.8355372532880555        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9395e+04 |  512 |      1 | 2.640e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1155.1259604304091 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.416976146986793, dt = 0.009384049212575274 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.3%)
   patch tree reduce : 13.03 us   (4.1%)
   gen split merge   : 737.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1045.00 ns (0.3%)
   LB compute        : 286.35 us  (91.2%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.4659775050016606e-18,-3.843458754385076e-17,6.6275110399693915e-18)
    sum a = (-1.4427497282802625e-16,-2.0280652157644853e-17,-7.795229305801454e-17)
    sum e = 2.5920009815607
    sum de = -8.063753657860939e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011234344590810044
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.1539037834437134e-18,-3.7950111803075617e-17,6.200118543575606e-18)
    sum a = (-5.4492543290207696e-18,2.1357915436226448e-17,1.3964317983200525e-16)
    sum e = 2.592000736507591
    sum de = -1.8973538018496328e-19
Info: CFL hydro = 0.004995545933827525 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004995545933827525 cfl multiplier : 0.4451790844293518        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4653e+04 |  512 |      1 | 3.494e-02 | 0.0% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 966.7988362802416 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.426360196199369, dt = 0.004995545933827525 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1313.00 ns (0.5%)
   gen split merge   : 801.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 955.00 ns  (0.3%)
   LB compute        : 273.12 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1903.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.48866443546092e-18,-3.7794962472192937e-17,7.9506713712707e-18)
    sum a = (1.7278658972358362e-16,-3.1193797545014944e-17,-1.5462240862684773e-17)
    sum e = 2.5920008053925416
    sum de = 4.404571325722362e-20
Info: CFL hydro = 0.007067694427409242 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007067694427409242 cfl multiplier : 0.6301193896195678        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8856e+04 |  512 |      1 | 2.715e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 662.3114508574229 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.431355742133196, dt = 0.007067694427409242 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.5%)
   patch tree reduce : 1460.00 ns (0.5%)
   gen split merge   : 734.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1027.00 ns (0.3%)
   LB compute        : 296.80 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.831786675468572e-18,-3.8014513412121255e-17,7.409112386114192e-18)
    sum a = (-6.388932351913956e-17,3.6767464073328427e-17,1.1369664975127703e-16)
    sum e = 2.592000870848745
    sum de = -8.944667923005412e-19
Info: CFL hydro = 0.008446274856789662 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008446274856789662 cfl multiplier : 0.7534129264130452        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9272e+04 |  512 |      1 | 2.657e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 957.7176788086005 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.438423436560605, dt = 0.008446274856789662 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.3%)
   patch tree reduce : 1419.00 ns (0.4%)
   gen split merge   : 669.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1008.00 ns (0.3%)
   LB compute        : 307.57 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.4140171158852927e-18,-3.753150134427896e-17,8.820093093386827e-18)
    sum a = (-4.7352746723738904e-17,1.144006764319805e-16,-6.183139937554482e-17)
    sum e = 2.592000924401768
    sum de = -2.1311348952918197e-18
Info: CFL hydro = 0.009360967261919768 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009360967261919768 cfl multiplier : 0.8356086176086969        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9198e+04 |  512 |      1 | 2.667e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1140.156106957318 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.446869711417395, dt = 0.009360967261919768 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.84 us    (1.6%)
   patch tree reduce : 1389.00 ns (0.5%)
   gen split merge   : 1135.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 936.00 ns  (0.3%)
   LB compute        : 289.26 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.611612961820776e-18,-3.6006354148243605e-17,7.429603807174167e-18)
    sum a = (-1.9870823736445332e-17,-4.426146948954823e-18,-9.242216367222333e-17)
    sum e = 2.592000963958246
    sum de = 4.2351647362715017e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.0115340406414907
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.493787290725914e-18,-3.6834793028239775e-17,7.318364664277155e-18)
    sum a = (1.1046046889673366e-16,1.417537962011828e-16,-1.6285410520122668e-16)
    sum e = 2.5920007384177675
    sum de = -1.2705494208814505e-18
Info: CFL hydro = 0.0049856561677275885 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0049856561677275885 cfl multiplier : 0.44520287253623225      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4451e+04 |  512 |      1 | 3.543e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 951.1793391784953 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.456230678679314, dt = 0.0049856561677275885 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.31 us    (1.8%)
   patch tree reduce : 1412.00 ns (0.5%)
   gen split merge   : 744.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1018.00 ns (0.3%)
   LB compute        : 278.69 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.42823339560716e-18,-3.5502850659341336e-17,6.153281009724232e-18)
    sum a = (-9.941266559954087e-18,3.8734640495086127e-17,3.9847031924056253e-17)
    sum e = 2.592000801708775
    sum de = 4.675621868843738e-19
Info: CFL hydro = 0.007055423062946269 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007055423062946269 cfl multiplier : 0.6301352483574881        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9299e+04 |  512 |      1 | 2.653e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 676.5490619279178 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.461216334847042, dt = 0.007055423062946269 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.5%)
   patch tree reduce : 1377.00 ns (0.5%)
   gen split merge   : 742.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1241.00 ns (0.4%)
   LB compute        : 283.25 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.78 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.940518922106561e-18,-3.5248171569024486e-17,6.888044822017658e-18)
    sum a = (3.247012034246488e-17,-2.5186883828576256e-17,-1.1557161477826483e-17)
    sum e = 2.5920008653061415
    sum de = 1.6737371037744975e-18
Info: CFL hydro = 0.008435149370226637 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008435149370226637 cfl multiplier : 0.753423498904992         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9287e+04 |  512 |      1 | 2.655e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 956.7899886624498 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.468271757909989, dt = 0.008435149370226637 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 1257.00 ns (0.4%)
   gen split merge   : 761.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1310.00 ns (0.5%)
   LB compute        : 273.93 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.178677160555309e-18,-3.5947807230929385e-17,6.6421477692979456e-18)
    sum a = (-3.6767464073328425e-18,-2.3172869872967183e-17,1.2702339180492573e-16)
    sum e = 2.592000920794918
    sum de = 1.2874900798265365e-19
Info: CFL hydro = 0.009356641854575324 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009356641854575324 cfl multiplier : 0.8356156659366615        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9741e+04 |  512 |      1 | 2.594e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1170.8244373875218 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.4767069072802155, dt = 0.009356641854575324 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.5%)
   patch tree reduce : 1342.00 ns (0.4%)
   gen split merge   : 700.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1211.00 ns (0.4%)
   LB compute        : 287.71 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1935.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.456043181331413e-18,-3.593902519333225e-17,8.445392822575836e-18)
    sum a = (2.0795865030009963e-17,-5.145103093573411e-17,-5.743452588524711e-17)
    sum e = 2.5920009659471566
    sum de = 4.1674021004911577e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010756879890551841
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.276011410590195e-18,-3.614393940393201e-17,7.614026596713952e-18)
    sum a = (1.5136720002417725e-16,3.604148229863213e-17,1.0290206187146822e-16)
    sum e = 2.5920007410628916
    sum de = -1.2807138162485021e-18
Info: CFL hydro = 0.00498801810693495 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00498801810693495 cfl multiplier : 0.4452052219788872         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4875e+04 |  512 |      1 | 3.442e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 978.6300971642797 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.486063549134791, dt = 0.00498801810693495 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.4%)
   patch tree reduce : 1731.00 ns (0.6%)
   gen split merge   : 787.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 287.93 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.41 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.996886131402593e-19,-3.547650454654994e-17,8.820093093386827e-18)
    sum a = (1.6767837118791818e-17,-1.4486849220229913e-16,7.227031473266976e-17)
    sum e = 2.5920008041610885
    sum de = -6.030874584450618e-19
Info: CFL hydro = 0.0070621030446179475 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070621030446179475 cfl multiplier : 0.6301368146525914       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0101e+04 |  512 |      1 | 2.547e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 704.9836908713728 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.491051567241725, dt = 0.0070621030446179475 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.6%)
   patch tree reduce : 1895.00 ns (0.6%)
   gen split merge   : 721.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1053.00 ns (0.4%)
   LB compute        : 277.09 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1948.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1219053030336878e-18,-3.686406648689689e-17,9.188938672466396e-18)
    sum a = (7.561919840304298e-17,-1.2880321809127792e-19,6.444844657949034e-17)
    sum e = 2.5920008709750246
    sum de = -2.642742795433417e-19
Info: CFL hydro = 0.008444496939101695 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008444496939101695 cfl multiplier : 0.7534245431017276        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0082e+04 |  512 |      1 | 2.549e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 997.2028881491477 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.498113670286343, dt = 0.0018863297136570978 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.5%)
   patch tree reduce : 1459.00 ns (0.5%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1512.00 ns (0.5%)
   LB compute        : 281.38 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0992183725744287e-18,-3.634299892280035e-17,9.333842292819084e-18)
    sum a = (4.206010539853366e-17,-7.806060485504584e-17,-8.477593627098656e-18)
    sum e = 2.592000750004698
    sum de = -8.538092108323347e-19
Info: CFL hydro = 0.009364204932298352 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009364204932298352 cfl multiplier : 0.8356163620678183        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0671e+04 |  512 |      1 | 2.477e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 274.1624588547826 (tsim/hr)                             [sph::Model][rank=0]
Info: iteration since start : 609                                                     [SPH][rank=0]
Info: time since start : 1752.7468654630002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14977646685521392 max=0.15028048766413868 delta=0.0005040208089247544
Number of particle pairs: 130816
Distance min=0.146944 max=1.991177 mean=0.806624
---------------- t = 4.5, dt = 0.009364204932298352 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 10.31 us   (1.8%)
   patch tree reduce : 1441.00 ns (0.3%)
   gen split merge   : 537.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 915.00 ns  (0.2%)
   LB compute        : 541.22 us  (95.6%)
   LB move op cnt    : 0
   LB apply          : 4.46 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.72 us    (82.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.202314052974889e-19,-3.72446214494393e-17,9.263585992042023e-18)
    sum a = (5.407393283141104e-17,-2.5816263189704092e-17,-2.37700484295722e-17)
    sum e = 2.592000974743484
    sum de = -2.879912020664621e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011305387753361013
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.572148324007152e-19,-3.6872848524494016e-17,9.183083980734974e-18)
    sum a = (5.43315392675936e-18,-2.7388247919590824e-17,3.100644740960945e-17)
    sum e = 2.592000741119315
    sum de = -2.1006417091906648e-19
Info: CFL hydro = 0.004984019196330034 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004984019196330034 cfl multiplier : 0.4452054540226061        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.2411e+04 |  512 |      1 | 4.125e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 817.1416065706261 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.509364204932298, dt = 0.004984019196330034 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.4%)
   patch tree reduce : 1524.00 ns (0.5%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 290.94 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.72 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.683239674164844e-19,-3.7174365148662235e-17,9.560711597411675e-18)
    sum a = (-9.107558457399634e-17,-6.291158999999213e-17,6.292622672932068e-17)
    sum e = 2.5920008068403977
    sum de = -1.8736368793265124e-18
Info: CFL hydro = 0.007051091673513159 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007051091673513159 cfl multiplier : 0.630136969348404         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9714e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 690.8653602375957 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.514348224128629, dt = 0.007051091673513159 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.96 us    (1.3%)
   patch tree reduce : 1236.00 ns (0.4%)
   gen split merge   : 670.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 969.00 ns  (0.3%)
   LB compute        : 279.22 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.62 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1994.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6993471449347312e-18,-3.773934290074443e-17,1.0075924469776787e-17)
    sum a = (1.7376725058859676e-17,5.4732219732962774e-17,-8.496328640639206e-17)
    sum e = 2.5920008774850727
    sum de = 9.893344823930228e-19
Info: CFL hydro = 0.008426844418679053 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008426844418679053 cfl multiplier : 0.7534246462322693        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9419e+04 |  512 |      1 | 2.637e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 962.7323995787151 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.5213993158021415, dt = 0.008426844418679053 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1481.00 ns (0.5%)
   gen split merge   : 669.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 278.36 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1954.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.221800980701071e-18,-3.671769919361134e-17,8.76447352193832e-18)
    sum a = (-1.0355778734538746e-16,8.413192018053018e-17,-1.5948180276392776e-16)
    sum e = 2.5920009420026835
    sum de = -7.572474548453445e-19
Info: CFL hydro = 0.009343747031555431 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009343747031555431 cfl multiplier : 0.8356164308215129        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9572e+04 |  512 |      1 | 2.616e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1159.6762847855252 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.5298261602208205, dt = 0.009343747031555431 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.2%)
   patch tree reduce : 1751.00 ns (0.5%)
   gen split merge   : 832.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 895.00 ns  (0.3%)
   LB compute        : 312.11 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.47 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.6737645300936584e-18,-3.587755093015232e-17,6.962692141593285e-18)
    sum a = (-3.346541793680657e-17,4.18259177292768e-17,-1.42784221945913e-16)
    sum e = 2.592000996108403
    sum de = 3.9302328752599536e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011852030161090822
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.1395239096014262e-18,-3.595658926852652e-17,7.078322303288864e-18)
    sum a = (4.885154780698287e-17,-4.482937458749614e-17,5.871084868269704e-17)
    sum e = 2.5920007434615173
    sum de = 6.352747104407253e-19
Info: CFL hydro = 0.004979478284296173 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004979478284296173 cfl multiplier : 0.44520547694050433       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4650e+04 |  512 |      1 | 3.495e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 962.489502776393 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 4.539169907252376, dt = 0.004979478284296173 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.6%)
   patch tree reduce : 1268.00 ns (0.4%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 923.00 ns  (0.3%)
   LB compute        : 271.58 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5734484028195882e-18,-3.674111796053703e-17,8.300489202223149e-18)
    sum a = (-7.763321235865206e-17,-1.0931880400910643e-16,9.892087149410145e-17)
    sum e = 2.592000814346167
    sum de = -1.3400061225563031e-18
Info: CFL hydro = 0.00704894511318132 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00704894511318132 cfl multiplier : 0.6301369846270028         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0568e+04 |  512 |      1 | 2.489e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 720.1364475132814 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.544149385536672, dt = 0.00704894511318132 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.5%)
   patch tree reduce : 1177.00 ns (0.4%)
   gen split merge   : 772.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 829.00 ns  (0.3%)
   LB compute        : 280.18 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1921.00 ns (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.5833827264898358e-18,-3.7636885795444553e-17,9.134050937484318e-18)
    sum a = (-2.780276009417548e-16,-9.712348113255498e-17,-1.0409641898467825e-16)
    sum e = 2.5920008900092006
    sum de = 2.8892293830844185e-18
Info: CFL hydro = 0.008430650887239434 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008430650887239434 cfl multiplier : 0.7534246564180019        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0346e+04 |  512 |      1 | 2.516e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1008.4095346496047 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.551198330649854, dt = 0.008430650887239434 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.70 us    (1.5%)
   patch tree reduce : 1402.00 ns (0.5%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 289.67 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.574398364779909e-18,-3.840970510399222e-17,7.491078070354096e-18)
    sum a = (-4.8921804107759924e-17,-5.909725833697088e-17,-3.0350721935690215e-17)
    sum e = 2.592000958109929
    sum de = -2.583450489125616e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010600269273900087
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.575441588106077e-18,-3.828675657763236e-17,7.848214265970821e-18)
    sum a = (3.9577716104410856e-17,-9.77499331478171e-17,7.517424183145494e-17)
    sum e = 2.592000743239642
    sum de = -4.783618569618661e-19
Info: CFL hydro = 0.004675282911226499 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004675282911226499 cfl multiplier : 0.41780821880600066       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4907e+04 |  512 |      1 | 3.435e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 883.6628167760562 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.559628981537093, dt = 0.004675282911226499 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.70 us    (1.6%)
   patch tree reduce : 1452.00 ns (0.5%)
   gen split merge   : 761.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1079.00 ns (0.4%)
   LB compute        : 272.89 us  (93.5%)
   LB move op cnt    : 0
   LB apply          : 3.49 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.968749157437501e-18,-3.891028124702878e-17,8.651770706108453e-18)
    sum a = (-1.3091090711458975e-17,-4.317249682750379e-17,4.6650183715968295e-17)
    sum e = 2.5920008088665702
    sum de = -3.815883427380623e-19
Info: CFL hydro = 0.006847128690389604 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006847128690389604 cfl multiplier : 0.6118721458706671        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9475e+04 |  512 |      1 | 2.629e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 640.197191641052 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 4.56430426444832, dt = 0.006847128690389604 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.02 us    (1.4%)
   patch tree reduce : 1306.00 ns (0.4%)
   gen split merge   : 758.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1112.00 ns (0.4%)
   LB compute        : 277.85 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.2124507007579305e-18,-3.9062503232045743e-17,8.932978868333303e-18)
    sum a = (-1.203022056972536e-16,1.185340887943642e-16,-3.1170378778089256e-17)
    sum e = 2.5920008866528463
    sum de = 1.7702988597614877e-19
Info: CFL hydro = 0.008296894639278341 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008296894639278341 cfl multiplier : 0.7412480972471114        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0316e+04 |  512 |      1 | 2.520e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 978.0971994056964 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.5711513931387096, dt = 0.008296894639278341 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.4%)
   patch tree reduce : 1388.00 ns (0.5%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 883.00 ns  (0.3%)
   LB compute        : 285.54 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.8268819456974705e-18,-3.749051850215901e-17,8.340259940195581e-18)
    sum a = (-7.027971954398638e-17,-9.938924683261518e-17,-2.9905765364102165e-17)
    sum e = 2.592000956535577
    sum de = -1.1401063470042883e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010558316949913552
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.324842129728058e-18,-3.853265363035208e-17,8.359036119537367e-18)
    sum a = (-3.0584909604947086e-17,-1.8020741149316065e-17,1.8290056968961465e-17)
    sum e = 2.592000743380787
    sum de = 5.014435047745458e-19
Info: CFL hydro = 0.004631443400978383 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004631443400978383 cfl multiplier : 0.41374936574903715       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4931e+04 |  512 |      1 | 3.429e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 871.0624121000632 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.579448287777988, dt = 0.004631443400978383 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.96 us    (1.4%)
   patch tree reduce : 1237.00 ns (0.4%)
   gen split merge   : 942.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 934.00 ns  (0.3%)
   LB compute        : 275.87 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.458036366617902e-18,-3.8122825209152553e-17,8.639878363529002e-18)
    sum a = (5.742281650178426e-17,5.2774191267035417e-17,-2.6884744430688555e-17)
    sum e = 2.5920008093834
    sum de = -1.4738373282224826e-18
Info: CFL hydro = 0.0068179303387744285 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0068179303387744285 cfl multiplier : 0.6091662438326915       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9955e+04 |  512 |      1 | 2.566e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 649.841565460241 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 4.584079731178966, dt = 0.0068179303387744285 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.5%)
   patch tree reduce : 1364.00 ns (0.5%)
   gen split merge   : 623.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 878.00 ns  (0.3%)
   LB compute        : 272.10 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.827193332557211e-18,-3.7629567430780277e-17,8.340374289643459e-18)
    sum a = (3.016337180028472e-17,-2.5257140129353316e-17,7.13101452887166e-17)
    sum e = 2.5920008875404528
    sum de = 1.3891340334970526e-19
Info: CFL hydro = 0.008275664855422077 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008275664855422077 cfl multiplier : 0.7394441625551277        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9980e+04 |  512 |      1 | 2.563e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 957.8160697752434 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.590897661517741, dt = 0.008275664855422077 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.5%)
   patch tree reduce : 1173.00 ns (0.4%)
   gen split merge   : 612.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 273.11 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 14.65 us   (92.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.6778986934059575e-18,-3.804378687077836e-17,9.23101926928599e-18)
    sum a = (-8.779695720440017e-17,2.6229018956769322e-17,3.7376352013396285e-17)
    sum e = 2.592000956324479
    sum de = -5.692061405548898e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010240734449547999
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.239949099622443e-18,-3.7853509389507156e-17,9.165885823773922e-18)
    sum a = (3.690797667488255e-17,-1.0985743564839723e-16,1.545638617095335e-17)
    sum e = 2.5920007435757624
    sum de = 3.049318610115481e-19
Info: CFL hydro = 0.004625455577650123 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004625455577650123 cfl multiplier : 0.4131480541850426        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4920e+04 |  512 |      1 | 3.432e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 868.189127150682 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 4.599173326373163, dt = 0.004625455577650123 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1703.00 ns (0.6%)
   gen split merge   : 678.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 943.00 ns  (0.3%)
   LB compute        : 268.90 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.75 us    (1.3%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1821.00 ns (64.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.4012645090962806e-18,-3.887368942370739e-17,9.134050937484318e-18)
    sum a = (-5.234094407891021e-17,1.1409623246194657e-16,7.114621392023679e-17)
    sum e = 2.5920008096127027
    sum de = 3.2864878353466853e-19
Info: CFL hydro = 0.0068170173919409 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0068170173919409 cfl multiplier : 0.608765369456695           [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9937e+04 |  512 |      1 | 2.568e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 648.3941396215441 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.603798781950813, dt = 0.0068170173919409 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.5%)
   patch tree reduce : 1401.00 ns (0.5%)
   gen split merge   : 1053.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 856.00 ns  (0.3%)
   LB compute        : 271.49 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1972.00 ns (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.02625285142555e-18,-3.748612748336044e-17,9.7224474564922e-18)
    sum a = (7.095886378483129e-18,-1.1395571986039244e-16,5.189598750732216e-17)
    sum e = 2.592000886698321
    sum de = 6.2002811739014785e-19
Info: CFL hydro = 0.008281460655134125 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008281460655134125 cfl multiplier : 0.73917691297113          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9567e+04 |  512 |      1 | 2.617e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 937.8948581083657 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.610615799342754, dt = 0.008281460655134125 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.66 us    (1.5%)
   patch tree reduce : 1344.00 ns (0.4%)
   gen split merge   : 656.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1272.00 ns (0.4%)
   LB compute        : 286.71 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.622279121957451e-18,-3.939036596900536e-17,1.000420449606687e-17)
    sum a = (-4.786795959610402e-17,-4.248164320319603e-17,-3.3840118207617565e-17)
    sum e = 2.5920009533897455
    sum de = 2.236166980751353e-19
Info: CFL hydro = 0.009263507357896229 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009263507357896229 cfl multiplier : 0.8261179419807533        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9642e+04 |  512 |      1 | 2.607e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1143.7346346294914 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.618897259997888, dt = 0.009263507357896229 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.5%)
   patch tree reduce : 1281.00 ns (0.4%)
   gen split merge   : 674.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1729.00 ns (0.6%)
   LB compute        : 276.31 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.70 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.5912306035077464e-18,-3.9504532457768083e-17,9.363115751476192e-18)
    sum a = (-4.983513601786171e-17,-2.0257233390719165e-17,-2.5222011978964787e-17)
    sum e = 2.5920010031994978
    sum de = 1.5585406229479126e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011124367948497367
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.313132746265215e-18,-3.94284214652596e-17,9.484600604903193e-18)
    sum a = (-5.084214299566625e-17,-2.1456274257314333e-16,-3.536233805778721e-18)
    sum e = 2.5920007442230895
    sum de = -2.574980159653073e-19
Info: CFL hydro = 0.004963944447353368 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004963944447353368 cfl multiplier : 0.4420393139935845        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4752e+04 |  512 |      1 | 3.471e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 960.8264706588222 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.628160767355784, dt = 0.004963944447353368 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1556.00 ns (0.5%)
   gen split merge   : 693.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 947.00 ns  (0.3%)
   LB compute        : 272.51 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.61 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1941.00 ns (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.6995424005390485e-18,-4.1307777511045975e-17,9.541683849284555e-18)
    sum a = (2.8676280100503606e-17,-4.081891075147226e-17,-7.992825151736937e-17)
    sum e = 2.5920008179906624
    sum de = 3.3881317890172014e-19
Info: CFL hydro = 0.0070553869191522945 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070553869191522945 cfl multiplier : 0.6280262093290564       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9531e+04 |  512 |      1 | 2.621e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 681.6835774869528 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.633124711803137, dt = 0.0070553869191522945 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (0.9%)
   patch tree reduce : 1770.00 ns (0.4%)
   gen split merge   : 683.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 973.00 ns  (0.2%)
   LB compute        : 457.39 us  (96.6%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (0.6%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.237021753756732e-18,-4.104138903726629e-17,8.782037597132586e-18)
    sum a = (-1.398217479298136e-16,3.3980630809171685e-17,4.690779015215085e-17)
    sum e = 2.5920008912689774
    sum de = -1.111307226797642e-18
Info: CFL hydro = 0.0084535720325593 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0084535720325593 cfl multiplier : 0.7520174728860377          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9543e+04 |  512 |      1 | 2.620e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 969.476557131961 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 4.640180098722289, dt = 0.0084535720325593 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.78 us    (1.6%)
   patch tree reduce : 1484.00 ns (0.5%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1119.00 ns (0.4%)
   LB compute        : 281.62 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.70 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.151505949931636e-18,-4.0561304315289706e-17,9.638286262853012e-18)
    sum a = (1.7815826938716306e-16,9.294908592805129e-17,3.292678629751577e-17)
    sum e = 2.5920009520252254
    sum de = 1.870248747537495e-18
Info: CFL hydro = 0.009392130001136817 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009392130001136817 cfl multiplier : 0.8346783152573586        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9711e+04 |  512 |      1 | 2.598e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1171.5908827615456 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.648633670754848, dt = 0.009392130001136817 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1364.00 ns (0.5%)
   gen split merge   : 795.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 933.00 ns  (0.3%)
   LB compute        : 286.51 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1945.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.97533568563535e-18,-3.9387438623139644e-17,9.916384120095546e-18)
    sum a = (-1.6151923548646252e-16,-1.3676559884601148e-17,-5.138077463495705e-17)
    sum e = 2.592000996098528
    sum de = 1.111307226797642e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011194436895072438
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.6761236336133615e-18,-3.987410987331408e-17,9.537292830485988e-18)
    sum a = (-2.0959796398489773e-18,-7.465902895908982e-17,5.023325505559839e-17)
    sum e = 2.5920007449486984
    sum de = 1.6872896309305663e-18
Info: CFL hydro = 0.005009840885688801 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005009840885688801 cfl multiplier : 0.4448927717524529        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4693e+04 |  512 |      1 | 3.485e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 970.2964189418041 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.658025800755985, dt = 0.005009840885688801 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.00 us    (1.7%)
   patch tree reduce : 1760.00 ns (0.6%)
   gen split merge   : 886.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 977.00 ns  (0.3%)
   LB compute        : 285.10 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1976.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.932577783722802e-18,-4.0647661018328174e-17,1.0242783184122306e-17)
    sum a = (3.990557884137047e-17,3.9179597066674176e-17,-4.4378563324176667e-17)
    sum e = 2.592000815806757
    sum de = -4.743384504624082e-20
Info: CFL hydro = 0.007092065444244029 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007092065444244029 cfl multiplier : 0.6299285145016352        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9292e+04 |  512 |      1 | 2.654e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 679.5527254290587 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.663035641641674, dt = 0.007092065444244029 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.88 us    (1.6%)
   patch tree reduce : 1596.00 ns (0.5%)
   gen split merge   : 741.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 984.00 ns  (0.3%)
   LB compute        : 277.65 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 3.34 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1941.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.642770543017427e-18,-3.9967784941016824e-17,9.730497657622906e-18)
    sum a = (-2.115885591735811e-17,-6.524468465496369e-17,-9.226994168720637e-18)
    sum e = 2.5920008847743863
    sum de = -1.0367683274392636e-18
Info: CFL hydro = 0.0084796929046423 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0084796929046423 cfl multiplier : 0.7532856763344234          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9848e+04 |  512 |      1 | 2.580e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 989.7246002618767 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.670127707085918, dt = 0.0084796929046423 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.4%)
   patch tree reduce : 1444.00 ns (0.5%)
   gen split merge   : 676.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 936.00 ns  (0.3%)
   LB compute        : 275.59 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1815.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.853539445348609e-18,-4.091990418383928e-17,9.606085458330193e-18)
    sum a = (-2.0068712316967385e-16,-5.777409800566957e-17,-1.4746797533105039e-16)
    sum e = 2.5920009418613588
    sum de = 5.827586677109586e-19
Info: CFL hydro = 0.009405832383799934 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009405832383799934 cfl multiplier : 0.835523784222949         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9818e+04 |  512 |      1 | 2.584e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1181.589422932919 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.67860739999056, dt = 0.009405832383799934 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.5%)
   patch tree reduce : 1706.00 ns (0.6%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 278.06 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1883.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.64037270950535e-18,-4.15224800343842e-17,7.871633032896507e-18)
    sum a = (3.979141235260775e-17,-1.7821681630447728e-17,-6.539690663998065e-17)
    sum e = 2.592000983927702
    sum de = 9.75781955236954e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01183001267219768
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.416742137638209e-18,-4.118190163882041e-17,8.258042687170342e-18)
    sum a = (-1.133819600707131e-16,-1.104429048215394e-16,-2.6943291348002775e-17)
    sum e = 2.5920007462308225
    sum de = 5.353248226647178e-19
Info: CFL hydro = 0.005013678946522441 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005013678946522441 cfl multiplier : 0.44517459474098303       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4427e+04 |  512 |      1 | 3.549e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 954.1292498727493 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.68801323237436, dt = 0.005013678946522441 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.5%)
   patch tree reduce : 1317.00 ns (0.5%)
   gen split merge   : 740.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1172.00 ns (0.4%)
   LB compute        : 274.01 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1998.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.695992280953857e-18,-4.233846054203392e-17,8.269752070633186e-18)
    sum a = (1.903506649178488e-17,-7.936620111115289e-17,-7.558407025265445e-18)
    sum e = 2.592000813127428
    sum de = -9.690056916589196e-19
Info: CFL hydro = 0.007098261878519185 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007098261878519185 cfl multiplier : 0.6301163964939888        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9482e+04 |  512 |      1 | 2.628e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 686.7845591231461 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.6930269113208825, dt = 0.007098261878519185 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1434.00 ns (0.5%)
   gen split merge   : 635.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1018.00 ns (0.3%)
   LB compute        : 296.49 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (68.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.20127082964872e-18,-4.2742725862594115e-17,8.179004348796149e-18)
    sum a = (5.0672122519086865e-17,-1.6999682911356117e-16,-8.664943762504152e-18)
    sum e = 2.5920008795499263
    sum de = 6.030874584450618e-19
Info: CFL hydro = 0.008489898804457984 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008489898804457984 cfl multiplier : 0.7534109309959925        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9334e+04 |  512 |      1 | 2.648e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 964.9630657431062 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.700125173199401, dt = 0.008489898804457984 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1357.00 ns (0.4%)
   gen split merge   : 699.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 289.58 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.738750182866404e-18,-4.4381490670042376e-17,8.102893356287666e-18)
    sum a = (4.744056709971023e-17,1.0177796105903525e-16,-6.609946964775126e-17)
    sum e = 2.592000936205575
    sum de = -2.303929616531697e-19
Info: CFL hydro = 0.009411601046067858 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009411601046067858 cfl multiplier : 0.8356072873306616        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9959e+04 |  512 |      1 | 2.565e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1191.4237709514193 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.70861507200386, dt = 0.009411601046067858 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.3%)
   patch tree reduce : 1362.00 ns (0.4%)
   gen split merge   : 654.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 979.00 ns  (0.3%)
   LB compute        : 295.92 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1956.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.28208422781551e-18,-4.236454936856759e-17,7.169070025125901e-18)
    sum a = (-1.136512758903585e-16,-5.447205186914772e-17,-7.938376518634716e-17)
    sum e = 2.592000979796131
    sum de = -1.3688052427629493e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011724739313530524
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.008066002511804e-18,-4.3100045017327445e-17,7.180779408588744e-18)
    sum a = (-4.642185073844285e-17,8.285559738308023e-17,4.8722744588891584e-17)
    sum e = 2.592000748127713
    sum de = -9.012430558785756e-19
Info: CFL hydro = 0.005010795138748765 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005010795138748765 cfl multiplier : 0.4452024291102205        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4094e+04 |  512 |      1 | 3.633e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 932.6986623420188 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.718026673049928, dt = 0.005010795138748765 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 2.34 us    (0.8%)
   gen split merge   : 891.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1008.00 ns (0.3%)
   LB compute        : 275.87 us  (93.7%)
   LB move op cnt    : 0
   LB apply          : 3.42 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1916.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.010993348377515e-18,-4.196130747556592e-17,7.924325258479303e-18)
    sum a = (-3.153922435716883e-17,-1.4212849647199377e-16,7.557675188799018e-17)
    sum e = 2.5920008130772594
    sum de = 3.1170812458958252e-19
Info: CFL hydro = 0.007089671264582565 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007089671264582565 cfl multiplier : 0.6301349527401471        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9590e+04 |  512 |      1 | 2.614e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 690.2117101377814 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.723037468188677, dt = 0.007089671264582565 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.5%)
   patch tree reduce : 1401.00 ns (0.5%)
   gen split merge   : 781.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1036.00 ns (0.3%)
   LB compute        : 280.99 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1954.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.242253671768673e-18,-4.350475058326197e-17,8.518576469218608e-18)
    sum a = (1.5925346978640232e-16,-6.250468892465833e-17,-1.3950632641278327e-17)
    sum e = 2.59200087947991
    sum de = -6.979551485375435e-19
Info: CFL hydro = 0.008473979675745912 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008473979675745912 cfl multiplier : 0.7534233018267648        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0038e+04 |  512 |      1 | 2.555e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 998.858505566426 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 4.730127139453259, dt = 0.008473979675745912 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.5%)
   patch tree reduce : 1599.00 ns (0.5%)
   gen split merge   : 734.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 900.00 ns  (0.3%)
   LB compute        : 298.33 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.198966257502491e-18,-4.367307297054035e-17,8.208277807453257e-18)
    sum a = (1.6650743284163382e-17,-6.393323370712522e-18,6.040578193894364e-18)
    sum e = 2.592000937803858
    sum de = -1.2739375526704677e-18
Info: CFL hydro = 0.0093971852286499 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0093971852286499 cfl multiplier : 0.8356155345511764          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9810e+04 |  512 |      1 | 2.585e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1180.356823805687 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.738601119129005, dt = 0.0093971852286499 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.5%)
   patch tree reduce : 2.10 us    (0.7%)
   gen split merge   : 806.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 871.00 ns  (0.3%)
   LB compute        : 275.93 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1924.00 ns (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.5648844907163484e-18,-4.3677463989338916e-17,8.310734912753138e-18)
    sum a = (-1.2506792476663087e-16,1.2301878266063325e-16,-8.177540675863293e-17)
    sum e = 2.592000984947299
    sum de = 7.860465750519907e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010772482339295487
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.153281009724232e-18,-4.297782832743402e-17,7.897979145687906e-18)
    sum a = (-5.804341382531497e-17,-4.309053114326389e-18,4.668531186635683e-17)
    sum e = 2.5920007503506697
    sum de = -4.675621868843738e-19
Info: CFL hydro = 0.005008468507680918 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005008468507680918 cfl multiplier : 0.44520517818372546       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4351e+04 |  512 |      1 | 3.568e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 948.212159624049 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 4.7479983043576555, dt = 0.005008468507680918 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1485.00 ns (0.5%)
   gen split merge   : 744.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 983.00 ns  (0.3%)
   LB compute        : 282.90 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1970.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.226464656367004e-18,-4.3575006884039036e-17,8.735200063281212e-18)
    sum a = (-5.597085295239168e-18,3.4378749846908365e-17,-6.712989539248149e-17)
    sum e = 2.5920008162127166
    sum de = 7.657177843178875e-19
Info: CFL hydro = 0.007090388085373178 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007090388085373178 cfl multiplier : 0.630136785455817         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9544e+04 |  512 |      1 | 2.620e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 688.2661096932701 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.753006772865336, dt = 0.007090388085373178 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.3%)
   patch tree reduce : 1327.00 ns (0.4%)
   gen split merge   : 733.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 894.00 ns  (0.3%)
   LB compute        : 286.13 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.1093708217385686e-18,-4.3351064925312157e-17,8.01507298031634e-18)
    sum a = (-5.52214524107697e-17,-1.1838186680934726e-17,-4.9846845401324555e-17)
    sum e = 2.592000885278461
    sum de = 7.928228386300251e-19
Info: CFL hydro = 0.008481682537195353 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008481682537195353 cfl multiplier : 0.7534245236372114        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9883e+04 |  512 |      1 | 2.575e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 991.2635836373817 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.76009716095071, dt = 0.008481682537195353 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1061.00 ns (0.3%)
   gen split merge   : 741.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 907.00 ns  (0.3%)
   LB compute        : 288.93 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.706549378343585e-18,-4.361452605322613e-17,7.657936784699615e-18)
    sum a = (-1.3606303583824086e-17,-1.1628588716949828e-16,-3.2411573425150666e-17)
    sum e = 2.592000947187883
    sum de = -8.131516293641283e-19
Info: CFL hydro = 0.009403780277781777 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009403780277781777 cfl multiplier : 0.8356163490914742        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9818e+04 |  512 |      1 | 2.583e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1181.8875713998943 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.768578843487905, dt = 0.009403780277781777 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.65 us    (1.3%)
   patch tree reduce : 1057.00 ns (0.4%)
   gen split merge   : 717.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 828.00 ns  (0.3%)
   LB compute        : 271.58 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.5338359722666435e-18,-4.509137204247726e-17,7.382766273322793e-18)
    sum a = (-1.1423674506350067e-16,5.1814021823082254e-17,8.698900974546397e-17)
    sum e = 2.5920009975061564
    sum de = -1.2332799712022613e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010508748740875963
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.010993348377515e-18,-4.435221721138527e-17,7.953598717136411e-18)
    sum a = (1.5245617268622168e-17,-2.789175140849309e-17,-1.8910654292492167e-17)
    sum e = 2.592000752471003
    sum de = -1.1858461261560205e-18
Info: CFL hydro = 0.005010368594685799 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005010368594685799 cfl multiplier : 0.4452054496971581        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5044e+04 |  512 |      1 | 3.403e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 994.7410985529483 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.777982623765687, dt = 0.005010368594685799 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.88 us    (1.8%)
   patch tree reduce : 1301.00 ns (0.5%)
   gen split merge   : 690.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1219.00 ns (0.4%)
   LB compute        : 261.97 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1956.00 ns (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.3684409308539804e-18,-4.4798637455906177e-17,7.417894423711323e-18)
    sum a = (-2.3863723497274945e-17,-6.919074688194194e-17,-5.725888513330446e-18)
    sum e = 2.592000821234171
    sum de = 7.657177843178875e-19
Info: CFL hydro = 0.007091679041800609 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007091679041800609 cfl multiplier : 0.630136966464772         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0650e+04 |  512 |      1 | 2.479e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 727.4809735278628 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.782992992360373, dt = 0.007091679041800609 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1236.00 ns (0.4%)
   gen split merge   : 725.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 891.00 ns  (0.3%)
   LB compute        : 294.58 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.74314120166497e-18,-4.536068786212266e-17,7.23639898003725e-18)
    sum a = (-7.142723912334503e-17,-3.6896267291419704e-17,-8.368696360894212e-17)
    sum e = 2.592000893439286
    sum de = 1.3552527156068805e-20
Info: CFL hydro = 0.008478856944921774 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008478856944921774 cfl multiplier : 0.753424644309848         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9529e+04 |  512 |      1 | 2.622e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 973.7696567909327 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.790084671402173, dt = 0.008478856944921774 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.5%)
   patch tree reduce : 1316.00 ns (0.5%)
   gen split merge   : 770.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 956.00 ns  (0.3%)
   LB compute        : 274.93 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.417894423711323e-18,-4.5520228211803906e-17,6.227928329299859e-18)
    sum a = (-7.57831297715228e-17,1.577195405527698e-16,-8.943627088919825e-17)
    sum e = 2.5920009575817695
    sum de = 2.6529071908004687e-18
Info: CFL hydro = 0.009383475007554237 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009383475007554237 cfl multiplier : 0.8356164295398987        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9456e+04 |  512 |      1 | 2.632e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1159.93330402905 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 4.798563528347095, dt = 0.009383475007554237 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1755.00 ns (0.6%)
   gen split merge   : 683.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1211.00 ns (0.4%)
   LB compute        : 290.99 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.186322713460425e-18,-4.332764615838647e-17,5.443399637289348e-18)
    sum a = (2.580748115210696e-16,-4.975902502535323e-17,-3.718900187799079e-17)
    sum e = 2.5920010078486424
    sum de = -1.2620790914089075e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.012285931530086943
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.667030209156488e-18,-4.433904415498957e-17,5.651241193754819e-18)
    sum a = (5.714179129867603e-18,-4.741714833278454e-17,-1.0842889086593032e-17)
    sum e = 2.5920007540937027
    sum de = -3.032377951170395e-19
Info: CFL hydro = 0.004989937833332745 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004989937833332745 cfl multiplier : 0.44520547651329956       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4593e+04 |  512 |      1 | 3.509e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 962.7915753644579 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.8079470033546485, dt = 0.004989937833332745 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.5%)
   patch tree reduce : 1553.00 ns (0.6%)
   gen split merge   : 733.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1406.00 ns (0.5%)
   LB compute        : 264.80 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1956.00 ns (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.723802066678108e-18,-4.447370206481227e-17,5.734670550927579e-18)
    sum a = (-5.84298234795888e-17,-1.0339971066863906e-16,5.475307707225596e-17)
    sum e = 2.592000825100535
    sum de = -2.498747194400186e-18
Info: CFL hydro = 0.007055751933837325 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007055751933837325 cfl multiplier : 0.6301369843421997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0158e+04 |  512 |      1 | 2.540e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 707.261764013207 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 4.812936941187981, dt = 0.007055751933837325 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1449.00 ns (0.5%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 931.00 ns  (0.3%)
   LB compute        : 283.99 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.214132499184679e-18,-4.5325559711734133e-17,6.308430340606908e-18)
    sum a = (1.390138004708774e-16,-7.526206220742626e-18,2.4191586234234562e-17)
    sum e = 2.592000898071638
    sum de = -6.500977870176755e-19
Info: CFL hydro = 0.008426155355006234 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008426155355006234 cfl multiplier : 0.753424656228133         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0374e+04 |  512 |      1 | 2.513e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1010.75034233497 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 4.819992693121819, dt = 0.008426155355006234 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.82 us    (1.3%)
   patch tree reduce : 1364.00 ns (0.5%)
   gen split merge   : 723.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 870.00 ns  (0.3%)
   LB compute        : 269.42 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.405032754175366e-18,-4.509137204247726e-17,6.325994415801173e-18)
    sum a = (-2.5456199648221656e-17,1.044886833306835e-16,-4.357061586524047e-17)
    sum e = 2.5920009610885777
    sum de = 4.836558128822055e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010661359450524436
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.142723912334503e-18,-4.448833879414082e-17,6.0508239044243514e-18)
    sum a = (1.0718769621886892e-16,4.770256455469135e-17,5.654461274207101e-17)
    sum e = 2.5920007540597383
    sum de = -1.5221182062159777e-18
Info: CFL hydro = 0.004668065480179552 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004668065480179552 cfl multiplier : 0.417808218742711         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4960e+04 |  512 |      1 | 3.423e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 886.3069732954734 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.828418848476825, dt = 0.004668065480179552 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.5%)
   patch tree reduce : 1232.00 ns (0.4%)
   gen split merge   : 683.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 922.00 ns  (0.3%)
   LB compute        : 274.33 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.09619776534287e-18,-4.4747408903256234e-17,6.7841240437849224e-18)
    sum a = (3.2294479590522227e-17,-1.4686274657331465e-16,8.606396845189934e-18)
    sum e = 2.5920008171681928
    sum de = -5.099138342470888e-19
Info: CFL hydro = 0.0068327426872105655 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0068327426872105655 cfl multiplier : 0.611872145828474        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9875e+04 |  512 |      1 | 2.576e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 652.3601052984372 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.833086913957004, dt = 0.0068327426872105655 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.5%)
   patch tree reduce : 1402.00 ns (0.5%)
   gen split merge   : 754.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 962.00 ns  (0.3%)
   LB compute        : 270.96 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1965.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.986422295378712e-18,-4.6168635321058857e-17,6.7577779309935244e-18)
    sum a = (4.4940613730393155e-17,-1.2631863328775583e-17,8.1227993081745e-17)
    sum e = 2.592000889782709
    sum de = 2.1006417091906648e-19
Info: CFL hydro = 0.008272701524528464 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008272701524528464 cfl multiplier : 0.7412480972189828        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9969e+04 |  512 |      1 | 2.564e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 959.3418655561949 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.839919656644215, dt = 0.008272701524528464 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1261.00 ns (0.4%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 864.00 ns  (0.3%)
   LB compute        : 285.58 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.634408955026981e-18,-4.5722215076537956e-17,7.747220833603796e-18)
    sum a = (-2.882850208552057e-17,9.297396836790983e-17,-6.166161331533359e-17)
    sum e = 2.5920009528647676
    sum de = -7.216720710606639e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010418778349724555
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.921288849866646e-18,-4.523920300869566e-17,7.129550855938804e-18)
    sum a = (9.156737867943576e-17,1.7124826947115257e-16,-8.512721777487187e-18)
    sum e = 2.5920007542914387
    sum de = 3.1509625637859973e-19
Info: CFL hydro = 0.004616416167030102 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004616416167030102 cfl multiplier : 0.4137493657396609        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4872e+04 |  512 |      1 | 3.443e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 865.0695590742768 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.848192358168743, dt = 0.004616416167030102 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1379.00 ns (0.5%)
   gen split merge   : 746.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 971.00 ns  (0.3%)
   LB compute        : 282.06 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.32 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1772.00 ns (63.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.035400807255896e-18,-4.4264396835413943e-17,7.34910179586712e-18)
    sum a = (-3.6931395441808235e-17,-5.749307280256133e-18,-1.257236502405501e-16)
    sum e = 2.592000815722401
    sum de = 7.318364664277155e-19
Info: CFL hydro = 0.006795960941601546 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.006795960941601546 cfl multiplier : 0.6091662438264406        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9886e+04 |  512 |      1 | 2.575e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 645.4678976213866 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.852808774335773, dt = 0.006795960941601546 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.5%)
   patch tree reduce : 1074.00 ns (0.4%)
   gen split merge   : 922.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 969.00 ns  (0.3%)
   LB compute        : 277.72 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1896.00 ns (63.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.63331120032734e-18,-4.457908651597786e-17,6.122543878134268e-18)
    sum a = (-7.41672348536504e-17,-4.200741317295087e-17,8.40031169624389e-17)
    sum e = 2.592000886829407
    sum de = 1.043544591017298e-18
Info: CFL hydro = 0.00824938015729607 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00824938015729607 cfl multiplier : 0.7394441625509603         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9344e+04 |  512 |      1 | 2.647e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 924.3333152398965 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.859604735277374, dt = 0.00824938015729607 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 1071.00 ns (0.4%)
   gen split merge   : 670.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 990.00 ns  (0.3%)
   LB compute        : 274.54 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1964.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.491572416330443e-18,-4.5081126331947276e-17,7.600853540318252e-18)
    sum a = (3.248182972592772e-17,3.037999539434733e-17,-3.666207962216284e-17)
    sum e = 2.592000947944874
    sum de = 5.421010862427522e-20
Info: CFL hydro = 0.009220928727797261 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009220928727797261 cfl multiplier : 0.8262961083673069        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9475e+04 |  512 |      1 | 2.629e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1129.6352546880194 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.86785411543467, dt = 0.009220928727797261 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.3%)
   patch tree reduce : 1210.00 ns (0.4%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 284.65 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.618217073207268e-18,-4.4385881688840943e-17,6.789246899049916e-18)
    sum a = (-3.8734640495086127e-17,8.05547035326315e-17,4.472984482806197e-17)
    sum e = 2.5920009932856365
    sum de = 6.979551485375435e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.012102702124232265
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.79009572831469e-18,-4.411071117746412e-17,7.176388389790178e-18)
    sum a = (-8.201252177375551e-17,6.264520152621245e-18,-9.687172938810385e-17)
    sum e = 2.592000754899138
    sum de = -6.369687763352339e-19
Info: CFL hydro = 0.004937656017367054 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004937656017367054 cfl multiplier : 0.4420987027891023        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4687e+04 |  512 |      1 | 3.486e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 952.2098417598269 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.877075044162467, dt = 0.004937656017367054 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.73 us    (1.6%)
   patch tree reduce : 1188.00 ns (0.4%)
   gen split merge   : 1004.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1023.00 ns (0.3%)
   LB compute        : 280.60 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1901.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.774610169721362e-18,-4.4483947775342256e-17,5.894942737075248e-18)
    sum a = (5.025667382252408e-17,9.865155567445605e-17,-3.258721417709332e-17)
    sum e = 2.592000822705441
    sum de = 1.0028870095490916e-18
Info: CFL hydro = 0.007017927807651276 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007017927807651276 cfl multiplier : 0.6280658018594015        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9499e+04 |  512 |      1 | 2.626e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 676.9593092148978 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.882012700179834, dt = 0.007017927807651276 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.5%)
   patch tree reduce : 1602.00 ns (0.6%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 270.81 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.37 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.869694378983492e-18,-4.370966479386174e-17,6.001059024707267e-18)
    sum a = (-1.1732802229769136e-16,1.601726563882355e-16,4.388676921873724e-17)
    sum e = 2.592000890000704
    sum de = -6.166399856011306e-19
Info: CFL hydro = 0.008410358565692394 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008410358565692394 cfl multiplier : 0.7520438679062676        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9658e+04 |  512 |      1 | 2.605e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 970.0006195809694 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.889030627987485, dt = 0.008410358565692394 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.5%)
   patch tree reduce : 1143.00 ns (0.4%)
   gen split merge   : 721.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1576.00 ns (0.5%)
   LB compute        : 275.98 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1901.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.366665871061384e-18,-4.202351357521228e-17,6.686057957283609e-18)
    sum a = (-3.2657470477870375e-17,1.2071788881018452e-16,2.4261842535011625e-17)
    sum e = 2.5920009458626234
    sum de = 1.5788694136820158e-18
Info: CFL hydro = 0.009346578907792343 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009346578907792343 cfl multiplier : 0.8346959119375118        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9539e+04 |  512 |      1 | 2.620e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1155.470385750318 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.897440986553177, dt = 0.009346578907792343 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.6%)
   patch tree reduce : 1359.00 ns (0.5%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1147.00 ns (0.4%)
   LB compute        : 271.27 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.435458498905589e-18,-4.1133600432036174e-17,6.910731752476917e-18)
    sum a = (-2.3652954594943764e-17,-1.1826477297471882e-17,4.4987451264244524e-17)
    sum e = 2.592000986503256
    sum de = -4.743384504624082e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011743148450902423
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.040632725267836e-18,-4.194593890977094e-17,6.8982905325476465e-18)
    sum a = (-4.609984269321465e-17,2.214244412823696e-17,3.18026854850828e-17)
    sum e = 2.5920007556105924
    sum de = 3.3881317890172014e-19
Info: CFL hydro = 0.004990181541790555 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004990181541790555 cfl multiplier : 0.4448986373125039        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.3372e+04 |  512 |      1 | 3.829e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 878.8018092406123 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.90678756546097, dt = 0.004990181541790555 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.4%)
   patch tree reduce : 1362.00 ns (0.5%)
   gen split merge   : 681.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1481.00 ns (0.5%)
   LB compute        : 279.00 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1945.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.496932762085518e-18,-4.145853582313008e-17,7.056367209296033e-18)
    sum a = (-3.017508118374756e-17,7.507471207202077e-17,-3.6931395441808235e-17)
    sum e = 2.5920008208705076
    sum de = -2.15485181781494e-18
Info: CFL hydro = 0.007072042128125612 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007072042128125612 cfl multiplier : 0.6299324248750026        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8977e+04 |  512 |      1 | 2.698e-02 | 0.0% |   4.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 665.8397054951051 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.911777747002761, dt = 0.007072042128125612 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.95 us    (1.6%)
   patch tree reduce : 1514.00 ns (0.5%)
   gen split merge   : 804.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1306.00 ns (0.4%)
   LB compute        : 293.56 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.786008166324465e-18,-4.112042737564048e-17,6.624217775870467e-18)
    sum a = (-1.6409529984828807e-16,2.618803611464937e-17,2.1955093992831465e-17)
    sum e = 2.5920008847199028
    sum de = 3.5236570605778894e-19
Info: CFL hydro = 0.008469117880379797 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008469117880379797 cfl multiplier : 0.7532882832500016        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9692e+04 |  512 |      1 | 2.600e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 979.2123863156702 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.918849789130887, dt = 0.008469117880379797 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1243.00 ns (0.4%)
   gen split merge   : 848.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 935.00 ns  (0.3%)
   LB compute        : 275.53 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1888.00 ns (64.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.583398527870934e-18,-4.0912585819175004e-17,7.003674983713237e-18)
    sum a = (-6.367562727094267e-17,-1.9314628021960266e-17,-3.953087857055948e-17)
    sum e = 2.5920009380901443
    sum de = -1.9244588561617704e-18
Info: CFL hydro = 0.009396038235503657 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009396038235503657 cfl multiplier : 0.8355255221666678        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0045e+04 |  512 |      1 | 2.554e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1193.6679510295878 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.927318907011267, dt = 0.009396038235503657 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.5%)
   patch tree reduce : 1214.00 ns (0.4%)
   gen split merge   : 944.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 861.00 ns  (0.3%)
   LB compute        : 289.96 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.57827567260594e-18,-4.1143846142566166e-17,6.324530742868317e-18)
    sum a = (-7.067783858172306e-17,-2.5936284370198238e-18,-1.7294759374619772e-17)
    sum e = 2.5920009772744312
    sum de = 3.1170812458958252e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011256400113554658
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.890769843770574e-18,-4.105456209366198e-17,6.4778504825849236e-18)
    sum a = (2.007515247787195e-16,-1.5737411374061593e-17,-8.773841028708596e-17)
    sum e = 2.5920007568388446
    sum de = 9.486769009248164e-19
Info: CFL hydro = 0.005000690313765409 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005000690313765409 cfl multiplier : 0.4451751740555559        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4699e+04 |  512 |      1 | 3.483e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 971.1078293703617 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.93671494524677, dt = 0.005000690313765409 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.6%)
   patch tree reduce : 1165.00 ns (0.4%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1266.00 ns (0.4%)
   LB compute        : 280.09 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1934.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.439849517704155e-18,-4.135754239076306e-17,5.648313847889108e-18)
    sum a = (-2.5883592144615443e-17,-7.943060272019852e-17,-1.2411946470614055e-17)
    sum e = 2.59200081867731
    sum de = 1.2874900798265365e-18
Info: CFL hydro = 0.007074096066420606 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007074096066420606 cfl multiplier : 0.6301167827037039        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9561e+04 |  512 |      1 | 2.617e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 687.7844051344986 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.941715635560535, dt = 0.007074096066420606 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.5%)
   patch tree reduce : 1316.00 ns (0.4%)
   gen split merge   : 672.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1191.00 ns (0.4%)
   LB compute        : 287.39 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.32 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.274874925898179e-18,-4.212304333464645e-17,5.881769680679549e-18)
    sum a = (1.3117436824250372e-17,7.376911581591373e-18,-1.2393211457073504e-16)
    sum e = 2.5920008799593948
    sum de = -2.100641709190665e-18
Info: CFL hydro = 0.008453097529042285 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008453097529042285 cfl multiplier : 0.7534111884691358        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9239e+04 |  512 |      1 | 2.661e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 956.955828726464 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 4.948789731626956, dt = 0.008453097529042285 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.3%)
   patch tree reduce : 1545.00 ns (0.5%)
   gen split merge   : 669.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 868.00 ns  (0.3%)
   LB compute        : 284.58 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.129971305545491e-18,-4.183762711273964e-17,4.403460018495564e-18)
    sum a = (7.660425028685469e-17,1.2651403362429203e-16,-1.579010359964439e-17)
    sum e = 2.5920009320865054
    sum de = 2.846030702774449e-18
Info: CFL hydro = 0.009371223841532743 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009371223841532743 cfl multiplier : 0.8356074589794238        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9633e+04 |  512 |      1 | 2.608e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1166.8985716502393 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.957242829155998, dt = 0.009371223841532743 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.5%)
   patch tree reduce : 1072.00 ns (0.4%)
   gen split merge   : 667.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 272.64 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1905.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.406185040248481e-18,-4.001754982073391e-17,4.749435707999267e-18)
    sum a = (-1.0736040962494586e-17,6.766852703177228e-17,-2.5994831287512453e-18)
    sum e = 2.592000972536979
    sum de = 7.589415207398531e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011473374000496967
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.964576264132828e-18,-4.013537549182877e-17,4.841006745861034e-18)
    sum a = (3.7721778825550164e-17,-5.698956931365906e-17,4.06139965408725e-17)
    sum e = 2.592000758636134
    sum de = -2.2090619264392153e-18
Info: CFL hydro = 0.004993256960027727 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004993256960027727 cfl multiplier : 0.4452024863264746        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4762e+04 |  512 |      1 | 3.468e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 972.6868412045519 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.966614052997531, dt = 0.004993256960027727 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1390.00 ns (0.5%)
   gen split merge   : 631.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 986.00 ns  (0.3%)
   LB compute        : 274.16 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.449363391767715e-18,-4.113725961436831e-17,5.273247658844904e-18)
    sum a = (1.0067142432179654e-17,4.2259164917402e-17,4.6269628753425884e-17)
    sum e = 2.592000818698101
    sum de = 5.014435047745458e-19
Info: CFL hydro = 0.007067815596396608 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007067815596396608 cfl multiplier : 0.6301349908843163        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9741e+04 |  512 |      1 | 2.594e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 693.0734834573334 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.971607309957559, dt = 0.007067815596396608 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.4%)
   patch tree reduce : 1312.00 ns (0.5%)
   gen split merge   : 662.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1321.00 ns (0.5%)
   LB compute        : 269.83 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (63.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.382766273322793e-18,-4.0668152439388146e-17,5.472856055063063e-18)
    sum a = (9.51328859438716e-17,-6.351755059419428e-17,7.653253031314478e-17)
    sum e = 2.592000880356993
    sum de = 1.8566962203814263e-18
Info: CFL hydro = 0.008453072256246084 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008453072256246084 cfl multiplier : 0.7534233272562109        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9983e+04 |  512 |      1 | 2.562e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 993.0598642440799 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.978675125553956, dt = 0.008453072256246084 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.81 us    (1.3%)
   patch tree reduce : 1288.00 ns (0.4%)
   gen split merge   : 654.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 872.00 ns  (0.3%)
   LB compute        : 274.62 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.3398993086632996e-18,-4.119727020461539e-17,6.391448039767301e-18)
    sum a = (-1.769287841235645e-17,2.9976021664879226e-18,8.49223035642721e-17)
    sum e = 2.592000934853713
    sum de = 4.607859233063394e-19
Info: CFL hydro = 0.009380483777761094 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009380483777761094 cfl multiplier : 0.8356155515041405        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0041e+04 |  512 |      1 | 2.555e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1191.1309561757714 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 4.987128197810201, dt = 0.009380483777761094 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.89 us    (1.4%)
   patch tree reduce : 1082.00 ns (0.4%)
   gen split merge   : 640.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 984.00 ns  (0.3%)
   LB compute        : 271.49 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.571891468520885e-18,-4.088258052405147e-17,7.166965995284921e-18)
    sum a = (6.385126802288532e-17,-7.87485311334879e-17,6.205973235307028e-19)
    sum e = 2.592000979328877
    sum de = -2.710505431213761e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010489162132104523
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.196459361243467e-18,-4.1268990178325305e-17,6.801596639420885e-18)
    sum a = (-9.735181411008043e-17,7.012749755896941e-17,-3.977677562327919e-17)
    sum e = 2.592000760779508
    sum de = 2.710505431213761e-19
Info: CFL hydro = 0.0050030703688774165 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0050030703688774165 cfl multiplier : 0.44520518383471347      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4714e+04 |  512 |      1 | 3.480e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 970.4767505655057 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 4.9965086815879625, dt = 0.0034913184120375362 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.99 us    (1.4%)
   patch tree reduce : 1364.00 ns (0.5%)
   gen split merge   : 645.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 949.00 ns  (0.3%)
   LB compute        : 275.05 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.586216810989699e-18,-4.069669406157883e-17,6.542618009863776e-18)
    sum a = (1.0379197501464432e-16,-5.6936877088076266e-18,4.513381855753007e-17)
    sum e = 2.592000789986418
    sum de = -3.3881317890172014e-19
Info: CFL hydro = 0.007084130165399033 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007084130165399033 cfl multiplier : 0.6301367892231423        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9915e+04 |  512 |      1 | 2.571e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 488.86789978690814 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 678                                                     [SPH][rank=0]
Info: time since start : 1755.35017033 (s)                                            [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.1497842839018818 max=0.15026263029538 delta=0.00047834639349819685
Number of particle pairs: 130816
Distance min=0.146043 max=1.990430 mean=0.806480
---------------- t = 5, dt = 0.007084130165399033 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.58 us    (1.6%)
   patch tree reduce : 1155.00 ns (0.2%)
   gen split merge   : 465.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 868.00 ns  (0.1%)
   LB compute        : 558.87 us  (96.0%)
   LB move op cnt    : 0
   LB apply          : 4.40 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.80 us    (81.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.525053934669511e-18,-4.05400810577633e-17,6.781745575269032e-18)
    sum a = (8.753935076821762e-17,-1.0519124633845411e-16,8.715879580567521e-17)
    sum e = 2.592000886332133
    sum de = -1.260385025514399e-18
Info: CFL hydro = 0.008475420850848368 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008475420850848368 cfl multiplier : 0.7534245261487614        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7710e+04 |  512 |      1 | 2.891e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 882.1504684448422 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.007084130165399, dt = 0.008475420850848368 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.86 us    (1.6%)
   patch tree reduce : 1015.00 ns (0.3%)
   gen split merge   : 674.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 843.00 ns  (0.3%)
   LB compute        : 281.52 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1942.00 ns (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.735402387394006e-18,-4.17600524472983e-17,7.71538594731419e-18)
    sum a = (-9.661412295192128e-17,-2.924418519845151e-17,9.437763071051819e-18)
    sum e = 2.5920009446738885
    sum de = -1.0299920638612292e-18
Info: CFL hydro = 0.009408359017590776 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009408359017590776 cfl multiplier : 0.8356163507658408        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9652e+04 |  512 |      1 | 2.605e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1171.1074638696791 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.015559551016247, dt = 0.009408359017590776 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.81 us    (1.3%)
   patch tree reduce : 1273.00 ns (0.4%)
   gen split merge   : 720.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1091.00 ns (0.4%)
   LB compute        : 274.18 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1940.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.513033164346928e-18,-4.197740787782733e-17,7.427225338658278e-18)
    sum a = (-1.8735013540549518e-17,-6.806335280541004e-17,6.809006483643465e-18)
    sum e = 2.5920009928424586
    sum de = -9.825582188149884e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010437014478535395
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.953910103996152e-18,-4.194593890977094e-17,7.441130231520404e-18)
    sum a = (2.4976114926245075e-17,4.215926923973462e-17,2.939640718346848e-17)
    sum e = 2.592000762691552
    sum de = -1.1045309632196076e-18
Info: CFL hydro = 0.005012777721036265 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005012777721036265 cfl multiplier : 0.44520545025528024       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.2523e+04 |  512 |      1 | 4.088e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 828.4243141879002 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.024967910033838, dt = 0.005012777721036265 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.95 us    (1.3%)
   patch tree reduce : 1779.00 ns (0.6%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 929.00 ns  (0.3%)
   LB compute        : 288.17 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.49 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.5971398266126415e-18,-4.1185560821152546e-17,7.63561577247357e-18)
    sum a = (-8.301952875156005e-18,-9.818391217240873e-17,-8.576245182773112e-17)
    sum e = 2.59200082726533
    sum de = 6.979551485375435e-19
Info: CFL hydro = 0.007093619980285163 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007093619980285163 cfl multiplier : 0.6301369668368535        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8580e+04 |  512 |      1 | 2.756e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 654.8666724582492 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.0299806877548745, dt = 0.007093619980285163 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.02 us    (1.4%)
   patch tree reduce : 1087.00 ns (0.4%)
   gen split merge   : 669.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 770.00 ns  (0.3%)
   LB compute        : 272.88 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (64.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.900851960180143e-18,-4.284756143640989e-17,6.682764693184684e-18)
    sum a = (-2.239536681103438e-16,-1.0565376698523643e-16,-3.016337180028472e-17)
    sum e = 2.592000895376741
    sum de = 3.1170812458958252e-19
Info: CFL hydro = 0.008478126307958089 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008478126307958089 cfl multiplier : 0.7534246445579024        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9594e+04 |  512 |      1 | 2.613e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 977.2653369858854 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.03707430773516, dt = 0.008478126307958089 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.4%)
   patch tree reduce : 904.00 ns  (0.3%)
   gen split merge   : 796.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 764.00 ns  (0.3%)
   LB compute        : 276.06 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1891.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.4227146837109e-18,-4.3402293477962093e-17,6.68239877495147e-18)
    sum a = (1.0498633212785435e-16,5.258391378576421e-17,2.1103236345909604e-17)
    sum e = 2.5920009560986266
    sum de = -3.9302328752599536e-19
Info: CFL hydro = 0.009400561597625538 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009400561597625538 cfl multiplier : 0.8356164297052683        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9613e+04 |  512 |      1 | 2.611e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1169.153315307806 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.045552434043118, dt = 0.009400561597625538 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.91 us    (1.3%)
   patch tree reduce : 942.00 ns  (0.3%)
   gen split merge   : 588.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 777.00 ns  (0.3%)
   LB compute        : 290.19 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.2245066374578e-18,-4.2393090990758275e-17,7.271893048658995e-18)
    sum a = (6.7914424084492e-18,-6.813690237028602e-17,4.752546012981584e-17)
    sum e = 2.5920010050201103
    sum de = -1.4433441421213278e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011061313322780634
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.646593319469984e-18,-4.2755350041639995e-17,7.334465066538565e-18)
    sum a = (-3.067858467264983e-17,2.1141291842163845e-17,-9.186011326600685e-17)
    sum e = 2.5920007642968264
    sum de = -1.1384122811097797e-18
Info: CFL hydro = 0.005008327089949914 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005008327089949914 cfl multiplier : 0.44520547656842274       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4426e+04 |  512 |      1 | 3.549e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 953.5377801544277 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.054952995640743, dt = 0.005008327089949914 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1023.00 ns (0.4%)
   gen split merge   : 585.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 726.00 ns  (0.3%)
   LB compute        : 272.71 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1974.00 ns (13.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.981225543744058e-18,-4.2215986565882765e-17,6.2257328199005755e-18)
    sum a = (1.347515848904024e-16,3.06961487478441e-17,8.609909660228787e-17)
    sum e = 2.5920008319021646
    sum de = -4.675621868843738e-19
Info: CFL hydro = 0.007088590497854925 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007088590497854925 cfl multiplier : 0.6301369843789485        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9844e+04 |  512 |      1 | 2.580e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 698.7963333967156 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.059961322730693, dt = 0.007088590497854925 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.5%)
   patch tree reduce : 1109.00 ns (0.4%)
   gen split merge   : 477.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 709.00 ns  (0.2%)
   LB compute        : 269.80 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.552131883927337e-18,-4.202644092107799e-17,7.201636747881934e-18)
    sum a = (5.786777307337232e-17,-3.665622493043141e-17,1.6738563660134708e-17)
    sum e = 2.592000901909533
    sum de = -7.318364664277155e-19
Info: CFL hydro = 0.008473662248709338 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008473662248709338 cfl multiplier : 0.7534246562526322        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0315e+04 |  512 |      1 | 2.520e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1012.5131898002828 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.067049913228548, dt = 0.008473662248709338 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.4%)
   patch tree reduce : 1571.00 ns (0.5%)
   gen split merge   : 480.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 713.00 ns  (0.2%)
   LB compute        : 272.64 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.59 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.3596588932568475e-18,-4.266021130100439e-17,7.128453101239162e-18)
    sum a = (1.7409511332555637e-16,-3.594780723092938e-18,5.595036153133171e-17)
    sum e = 2.5920009627796796
    sum de = 8.605854744103691e-19
Info: CFL hydro = 0.009395406270696743 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009395406270696743 cfl multiplier : 0.8356164375017547        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0184e+04 |  512 |      1 | 2.537e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1202.544012543817 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.075523575477257, dt = 0.009395406270696743 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.3%)
   patch tree reduce : 13.51 us   (4.5%)
   gen split merge   : 500.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1056.00 ns (0.3%)
   LB compute        : 275.14 us  (91.1%)
   LB move op cnt    : 0
   LB apply          : 2.57 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1971.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.374918396304883e-18,-4.220208167302064e-17,7.776494292260904e-18)
    sum a = (2.2528853782510794e-17,-6.983476297239832e-17,-4.574563384346364e-17)
    sum e = 2.592001009507903
    sum de = 1.1773757966834775e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01121844082685816
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.054794473616231e-18,-4.272314923711717e-17,7.249937954666164e-18)
    sum a = (-1.225972448559709e-16,1.456647302777725e-17,-8.275606762364606e-18)
    sum e = 2.5920007652035344
    sum de = 1.2586909596198903e-18
Info: CFL hydro = 0.005005723821850032 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005005723821850032 cfl multiplier : 0.44520547916725156       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.3322e+04 |  512 |      1 | 3.843e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 880.0414179327595 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.084918981747954, dt = 0.005005723821850032 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.96 us    (1.3%)
   patch tree reduce : 990.00 ns  (0.3%)
   gen split merge   : 462.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 687.00 ns  (0.2%)
   LB compute        : 299.93 us  (95.7%)
   LB move op cnt    : 0
   LB apply          : 2.42 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.468702526754577e-18,-4.235869467683617e-17,7.404721367315625e-18)
    sum a = (-1.1397913862731811e-16,-1.298219344525453e-16,-1.0752141364755995e-17)
    sum e = 2.59200083391479
    sum de = -5.857232830263487e-19
Info: CFL hydro = 0.007084946546138066 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007084946546138066 cfl multiplier : 0.630136986111501         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0433e+04 |  512 |      1 | 2.506e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 719.1612705907413 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.089924705569804, dt = 0.007084946546138066 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.4%)
   patch tree reduce : 1117.00 ns (0.4%)
   gen split merge   : 537.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 718.00 ns  (0.2%)
   LB compute        : 273.41 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.40 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1737.00 ns (63.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.16321533339448e-18,-4.380333986156448e-17,7.35202914173283e-18)
    sum a = (2.915636482248019e-17,-9.403805859009573e-17,-2.4449192670417118e-17)
    sum e = 2.592000902762568
    sum de = -2.253107639696439e-19
Info: CFL hydro = 0.008468435767692727 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008468435767692727 cfl multiplier : 0.7534246574076674        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0577e+04 |  512 |      1 | 2.488e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1025.0807294781673 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.0970096521159425, dt = 0.008468435767692727 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.4%)
   patch tree reduce : 1187.00 ns (0.4%)
   gen split merge   : 725.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 677.00 ns  (0.2%)
   LB compute        : 272.85 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.43 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1950.00 ns (64.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.299648303009775e-18,-4.4238050722622546e-17,7.024532323006427e-18)
    sum a = (-3.629908873481469e-17,-4.758693439299577e-17,1.193420362533004e-16)
    sum e = 2.592000960422125
    sum de = 7.352245982167327e-19
Info: CFL hydro = 0.009387926392690555 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009387926392690555 cfl multiplier : 0.8356164382717782        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9604e+04 |  512 |      1 | 2.612e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1167.298901777225 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.105478087883635, dt = 0.009387926392690555 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.3%)
   patch tree reduce : 1330.00 ns (0.4%)
   gen split merge   : 780.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 317.02 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.964155814526141e-18,-4.4582013861843574e-17,8.753495974941905e-18)
    sum a = (1.2739809207573672e-17,-7.628663326042506e-17,6.403276346655939e-17)
    sum e = 2.5920010020922346
    sum de = -7.081195439045951e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011039470217027017
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.721186107672139e-18,-4.451322123399937e-17,8.529554016215024e-18)
    sum a = (-6.700109217439021e-17,-9.538463768832273e-17,2.6229018956769322e-17)
    sum e = 2.5920007655515502
    sum de = -4.980553729855286e-19
Info: CFL hydro = 0.005000969718865559 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005000969718865559 cfl multiplier : 0.44520547942392613       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4833e+04 |  512 |      1 | 3.452e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 979.1284050743288 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.114866014276326, dt = 0.005000969718865559 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.59 us    (1.5%)
   patch tree reduce : 1343.00 ns (0.4%)
   gen split merge   : 691.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 902.00 ns  (0.3%)
   LB compute        : 288.54 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.394475656785637e-18,-4.532848705759984e-17,8.483448318830077e-18)
    sum a = (8.301952875156005e-17,8.773841028708596e-17,1.110635021450701e-17)
    sum e = 2.592000832130878
    sum de = -8.470329472543003e-19
Info: CFL hydro = 0.0070777832882089045 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070777832882089045 cfl multiplier : 0.6301369862826175       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0205e+04 |  512 |      1 | 2.534e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 710.4583654621607 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.119866983995192, dt = 0.0070777832882089045 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 1099.00 ns (0.4%)
   gen split merge   : 923.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 953.00 ns  (0.3%)
   LB compute        : 277.76 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1935.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.470898036153861e-18,-4.4043382222552773e-17,8.471007098900806e-18)
    sum a = (8.262140971382337e-17,-1.0854598470055876e-16,2.2391268526822383e-17)
    sum e = 2.592000896595068
    sum de = 8.131516293641283e-20
Info: CFL hydro = 0.008462792921443096 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008462792921443096 cfl multiplier : 0.753424657521745         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9988e+04 |  512 |      1 | 2.562e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 994.7175323572638 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.126944767283401, dt = 0.008462792921443096 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.79 us    (1.3%)
   patch tree reduce : 964.00 ns  (0.3%)
   gen split merge   : 770.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1073.00 ns (0.4%)
   LB compute        : 276.54 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1957.00 ns (64.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.869328460750278e-18,-4.578368933971788e-17,8.798137999393995e-18)
    sum a = (-1.9554670382948556e-17,0,-6.399178062443944e-18)
    sum e = 2.5920009489436797
    sum de = -6.979551485375435e-19
Info: CFL hydro = 0.009388070140996827 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009388070140996827 cfl multiplier : 0.83561643834783          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9837e+04 |  512 |      1 | 2.581e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1180.3727034746482 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.135407560204844, dt = 0.009388070140996827 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1560.00 ns (0.5%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 801.00 ns  (0.3%)
   LB compute        : 279.84 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.547009028662343e-18,-4.519529282071e-17,8.536872380879301e-18)
    sum a = (8.126312123213353e-18,-1.5397839253639135e-17,1.2265579177328512e-18)
    sum e = 2.5920009852887156
    sum de = 1.7957098481791167e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01134580121033694
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.3479495097940044e-18,-4.5329950730532694e-17,8.565414003069982e-18)
    sum a = (-8.276192231537748e-17,-8.471738935367234e-17,5.268051619933267e-17)
    sum e = 2.5920007657975086
    sum de = -2.89346454782069e-18
Info: CFL hydro = 0.005004557569512479 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005004557569512479 cfl multiplier : 0.44520547944927663       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4692e+04 |  512 |      1 | 3.485e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 969.7996003385234 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.144795630345841, dt = 0.005004557569512479 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.4%)
   patch tree reduce : 1246.00 ns (0.4%)
   gen split merge   : 764.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 869.00 ns  (0.3%)
   LB compute        : 296.72 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1989.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.230544288305829e-18,-4.601348599017618e-17,9.144296648014305e-18)
    sum a = (-5.518632426038117e-17,-2.1275949751986544e-17,-5.862302830672572e-17)
    sum e = 2.592000827678291
    sum de = 5.488773498207866e-19
Info: CFL hydro = 0.0070853483465410485 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070853483465410485 cfl multiplier : 0.6301369862995178       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9947e+04 |  512 |      1 | 2.567e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 701.8976814113762 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.149800187915353, dt = 0.0070853483465410485 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.5%)
   patch tree reduce : 1072.00 ns (0.3%)
   gen split merge   : 944.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1186.00 ns (0.4%)
   LB compute        : 300.19 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1994.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.499860107951228e-18,-4.60852059638861e-17,8.369281830067354e-18)
    sum a = (-5.675538164440219e-17,-1.8073433374898862e-16,1.1765003034291955e-17)
    sum e = 2.592000886542013
    sum de = 3.049318610115481e-19
Info: CFL hydro = 0.008474849385126429 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008474849385126429 cfl multiplier : 0.7534246575330119        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0013e+04 |  512 |      1 | 2.558e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 997.0088487532579 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.156885536261894, dt = 0.008474849385126429 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.75 us    (1.2%)
   patch tree reduce : 1371.00 ns (0.4%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 881.00 ns  (0.3%)
   LB compute        : 293.89 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1924.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.938961987807858e-18,-4.80260362728524e-17,8.80984738285684e-18)
    sum a = (2.1580393722020476e-17,-3.062003775533562e-17,5.427299235027938e-18)
    sum e = 2.5920009339166805
    sum de = -1.531435568635775e-18
Info: CFL hydro = 0.009392459834941289 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009392459834941289 cfl multiplier : 0.8356164383553413        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0131e+04 |  512 |      1 | 2.543e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1199.591077512424 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.165360385647021, dt = 0.009392459834941289 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.65 us    (1.5%)
   patch tree reduce : 1224.00 ns (0.4%)
   gen split merge   : 717.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1232.00 ns (0.4%)
   LB compute        : 293.18 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1895.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.321292010142866e-18,-4.7674754768967096e-17,8.787892288864008e-18)
    sum a = (1.5360369226558034e-16,4.98585547847874e-17,1.87847784202666e-16)
    sum e = 2.5920009665664825
    sum de = 2.846030702774449e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011818569484935548
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.715331415940718e-18,-4.737031079893317e-17,9.679269104972964e-18)
    sum a = (-4.407411935414274e-17,-6.619314471545401e-17,1.3308007040108148e-16)
    sum e = 2.5920007665163034
    sum de = -9.0801931945661e-19
Info: CFL hydro = 0.0050017944955365575 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0050017944955365575 cfl multiplier : 0.4452054794517804       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4380e+04 |  512 |      1 | 3.560e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 949.6713436054315 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.174752845481962, dt = 0.0050017944955365575 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.4%)
   patch tree reduce : 1311.00 ns (0.4%)
   gen split merge   : 733.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 724.00 ns  (0.2%)
   LB compute        : 276.29 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.874560378762218e-18,-4.820753171652647e-17,1.0083242834441063e-17)
    sum a = (-1.3221064867896536e-16,8.511550839140902e-17,5.4782350530913073e-17)
    sum e = 2.5920008227395934
    sum de = 7.860465750519907e-19
Info: CFL hydro = 0.007077773924540383 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007077773924540383 cfl multiplier : 0.6301369863011869        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0088e+04 |  512 |      1 | 2.549e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 706.4878291859042 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.1797546399774985, dt = 0.007077773924540383 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.5%)
   patch tree reduce : 1250.00 ns (0.4%)
   gen split merge   : 1006.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 889.00 ns  (0.3%)
   LB compute        : 274.68 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1861.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.20357540179495e-18,-4.731176388161895e-17,1.0237660328857311e-17)
    sum a = (2.1890692383785826e-17,-5.794973875761222e-17,6.493438599319834e-17)
    sum e = 2.5920008768607223
    sum de = -4.87890977618477e-19
Info: CFL hydro = 0.008460780057156657 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008460780057156657 cfl multiplier : 0.7534246575341245        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9630e+04 |  512 |      1 | 2.608e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 976.9171425949901 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.186832413902039, dt = 0.008460780057156657 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.4%)
   patch tree reduce : 1032.00 ns (0.3%)
   gen split merge   : 748.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1532.00 ns (0.5%)
   LB compute        : 317.27 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.404409980455884e-18,-4.824851455864643e-17,1.0897776821575112e-17)
    sum a = (-6.316041439857756e-17,6.614045248987122e-17,9.335013231165368e-17)
    sum e = 2.592000921648634
    sum de = -1.2468324983583301e-18
Info: CFL hydro = 0.00938319822331234 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00938319822331234 cfl multiplier : 0.8356164383560829         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9591e+04 |  512 |      1 | 2.613e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1165.4470906403576 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.195293193959196, dt = 0.00938319822331234 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.4%)
   patch tree reduce : 1243.00 ns (0.4%)
   gen split merge   : 702.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 919.00 ns  (0.3%)
   LB compute        : 299.21 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.481673259037482e-18,-4.7054157445436394e-17,1.180159485761334e-17)
    sum a = (3.7955966494807036e-17,9.404391328182716e-17,1.455037262551584e-17)
    sum e = 2.5920009553397483
    sum de = -5.692061405548898e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011113944948316329
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.992806499463768e-18,-4.701902929504786e-17,1.1369811342420987e-17)
    sum a = (-2.7361901806799427e-17,6.129862242798545e-17,-5.513655938066409e-17)
    sum e = 2.5920007681085417
    sum de = 2.3852447794681098e-18
Info: CFL hydro = 0.005000671544419223 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005000671544419223 cfl multiplier : 0.44520547945202765       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4708e+04 |  512 |      1 | 3.481e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 970.3466248104894 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.204676392182508, dt = 0.005000671544419223 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.5%)
   patch tree reduce : 1433.00 ns (0.5%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1012.00 ns (0.3%)
   LB compute        : 286.04 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.349942695080493e-18,-4.682582446791095e-17,1.0869235199384431e-17)
    sum a = (1.7398899703792436e-16,6.469434363221005e-18,7.467220201548553e-17)
    sum e = 2.5920008206900516
    sum de = -1.666960840196463e-18
Info: CFL hydro = 0.007079054649599587 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007079054649599587 cfl multiplier : 0.6301369863013518        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9159e+04 |  512 |      1 | 2.672e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 673.6558641336717 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.209677063726927, dt = 0.007079054649599587 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1694.00 ns (0.6%)
   gen split merge   : 667.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 870.00 ns  (0.3%)
   LB compute        : 288.75 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.652082092968194e-18,-4.6992683182256465e-17,1.164132267146567e-17)
    sum a = (9.296884551264484e-17,1.687849079251569e-16,1.3346648005535533e-16)
    sum e = 2.592000874042707
    sum de = 8.131516293641283e-19
Info: CFL hydro = 0.008465198335443432 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008465198335443432 cfl multiplier : 0.7534246575342346        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9545e+04 |  512 |      1 | 2.620e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 972.865154730706 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 5.2167561183765265, dt = 0.008465198335443432 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.4%)
   patch tree reduce : 1604.00 ns (0.5%)
   gen split merge   : 607.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1615.00 ns (0.6%)
   LB compute        : 275.66 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1797.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.107595761945973e-18,-4.502843410636448e-17,1.2963019329834124e-17)
    sum a = (-7.461804611696986e-18,-8.38977325112733e-17,-5.621016347691354e-17)
    sum e = 2.5920009211318162
    sum de = 1.4772254600114998e-18
Info: CFL hydro = 0.009387028189941115 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009387028189941115 cfl multiplier : 0.8356164383561563        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9120e+04 |  512 |      1 | 2.678e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1138.0407250097487 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.22522131671197, dt = 0.009387028189941115 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.90 us    (1.3%)
   patch tree reduce : 1227.00 ns (0.4%)
   gen split merge   : 1048.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 925.00 ns  (0.3%)
   LB compute        : 273.44 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.666718822296747e-18,-4.6913644843882274e-17,1.1685232859451333e-17)
    sum a = (5.881037844213121e-17,-1.504392313847469e-16,-7.8719623593064e-17)
    sum e = 2.5920009601359664
    sum de = 2.846030702774449e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011129794427576847
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.502787453816939e-18,-4.726785369363329e-17,1.1570334534222182e-17)
    sum a = (8.595272930900233e-17,3.6029772915169286e-17,1.0192871937111935e-16)
    sum e = 2.592000770589528
    sum de = -1.7753810574450135e-18
Info: CFL hydro = 0.005002840962081135 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005002840962081135 cfl multiplier : 0.4452054794520521        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4262e+04 |  512 |      1 | 3.590e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 941.3071806361365 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.234608344901911, dt = 0.005002840962081135 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1778.00 ns (0.6%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 914.00 ns  (0.3%)
   LB compute        : 290.44 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.709476724209296e-18,-4.6275483445157303e-17,1.2894958538456347e-17)
    sum a = (-2.415060339211461e-17,1.416249929830915e-17,-4.090755444346832e-17)
    sum e = 2.5920008237110155
    sum de = -7.860465750519907e-19
Info: CFL hydro = 0.007079195130915516 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007079195130915516 cfl multiplier : 0.630136986301368         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9628e+04 |  512 |      1 | 2.608e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 690.4506651241591 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.239611185863993, dt = 0.007079195130915516 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.89 us    (1.3%)
   patch tree reduce : 1867.00 ns (0.6%)
   gen split merge   : 776.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 868.00 ns  (0.3%)
   LB compute        : 274.62 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1978.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.110523107811684e-18,-4.609984269321465e-17,1.2280947743123493e-17)
    sum a = (-9.989275032151745e-17,-8.575293795366756e-18,6.010938817004041e-18)
    sum e = 2.592000880909802
    sum de = 1.8973538018496328e-18
Info: CFL hydro = 0.008460819968797204 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008460819968797204 cfl multiplier : 0.7534246575342453        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0030e+04 |  512 |      1 | 2.556e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 997.0099785605909 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.246690380994909, dt = 0.008460819968797204 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.94 us    (1.3%)
   patch tree reduce : 1098.00 ns (0.4%)
   gen split merge   : 686.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 914.00 ns  (0.3%)
   LB compute        : 277.58 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.255115341304631e-18,-4.6304756903814416e-17,1.2494643991320387e-17)
    sum a = (1.1486905177049422e-17,-1.721864838211129e-17,9.594961544040493e-17)
    sum e = 2.5920009340592567
    sum de = -1.2061749168901237e-18
Info: CFL hydro = 0.009381479029151913 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009381479029151913 cfl multiplier : 0.8356164383561634        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0122e+04 |  512 |      1 | 2.544e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1197.0843072162786 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.255151200963706, dt = 0.009381479029151913 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.3%)
   patch tree reduce : 1556.00 ns (0.5%)
   gen split merge   : 653.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1622.00 ns (0.5%)
   LB compute        : 290.98 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1872.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.546697641802602e-18,-4.639257727978574e-17,1.3710956198523249e-17)
    sum a = (1.5499710889765872e-16,-1.130540973337535e-16,-3.6486438870220186e-17)
    sum e = 2.5920009807273447
    sum de = -3.2526065174565133e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01047732188599641
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.990501927317538e-18,-4.677605958819386e-17,1.3133537226511782e-17)
    sum a = (-2.1286488197103103e-16,-5.31196180791893e-17,-1.5031921020425277e-17)
    sum e = 2.5920007735099833
    sum de = 1.463672932855431e-18
Info: CFL hydro = 0.004999170097741502 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004999170097741502 cfl multiplier : 0.4452054794520544        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4670e+04 |  512 |      1 | 3.490e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 967.6989005692238 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.264532679992858, dt = 0.004999170097741502 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1471.00 ns (0.5%)
   gen split merge   : 744.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 819.00 ns  (0.3%)
   LB compute        : 284.66 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.938339214088376e-18,-4.6749713475402465e-17,1.3085236019727553e-17)
    sum a = (-2.2136589436505538e-16,2.495855085105081e-17,-8.487839337628644e-17)
    sum e = 2.5920008315422995
    sum de = -9.893344823930228e-19
Info: CFL hydro = 0.007076508412630938 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007076508412630938 cfl multiplier : 0.6301369863013696        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9846e+04 |  512 |      1 | 2.580e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 697.6033406122007 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.269531850090599, dt = 0.007076508412630938 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.6%)
   patch tree reduce : 1102.00 ns (0.4%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1231.00 ns (0.4%)
   LB compute        : 281.07 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1934.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1658154910193508e-17,-4.650381642268275e-17,1.242292401761047e-17)
    sum a = (1.8479748981059528e-16,-8.85346483625593e-17,6.412643853426214e-17)
    sum e = 2.5920008960951497
    sum de = 1.4365678785432934e-18
Info: CFL hydro = 0.008463699876224142 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008463699876224142 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8851e+04 |  512 |      1 | 2.716e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 937.9585692369945 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.27660835850323, dt = 0.008463699876224142 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.69 us    (1.5%)
   patch tree reduce : 1174.00 ns (0.4%)
   gen split merge   : 731.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1262.00 ns (0.4%)
   LB compute        : 292.20 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.533213198547162e-18,-4.766304538550425e-17,1.3333328581846549e-17)
    sum a = (5.37929076283028e-17,-8.828875130983959e-17,1.0617483454933297e-17)
    sum e = 2.5920009572063356
    sum de = -2.981555974335137e-19
Info: CFL hydro = 0.009392745462434501 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009392745462434501 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9848e+04 |  512 |      1 | 2.580e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1181.1817211480097 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.285072058379455, dt = 0.009392745462434501 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.5%)
   patch tree reduce : 1719.00 ns (0.6%)
   gen split merge   : 713.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 799.00 ns  (0.3%)
   LB compute        : 282.64 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1856.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.493694029360067e-18,-4.860857810012886e-17,1.3398462027358615e-17)
    sum a = (-7.730534962169244e-17,1.508168590014236e-17,3.984117723232483e-17)
    sum e = 2.5920010109540694
    sum de = 6.369687763352339e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010663272503384936
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.228457841653492e-18,-4.826022394210927e-17,1.3386020807429343e-17)
    sum a = (8.908498938531295e-17,-1.4507926110463033e-17,-7.842945043412542e-17)
    sum e = 2.5920007761582387
    sum de = -8.267041565201971e-19
Info: CFL hydro = 0.005009847701576274 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005009847701576274 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4000e+04 |  512 |      1 | 3.657e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 924.5748084124019 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.294464803841889, dt = 0.005009847701576274 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 1457.00 ns (0.5%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 789.00 ns  (0.3%)
   LB compute        : 288.25 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1872.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.672573514028169e-18,-4.833340758875204e-17,1.2491716645454676e-17)
    sum a = (-6.372246480479404e-17,-2.941397125866274e-17,-1.927247424149403e-16)
    sum e = 2.592000842132306
    sum de = 1.2265037076242269e-18
Info: CFL hydro = 0.007093383271830206 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007093383271830206 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0258e+04 |  512 |      1 | 2.527e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 713.5836343059385 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.2994746515434645, dt = 0.007093383271830206 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.4%)
   patch tree reduce : 1529.00 ns (0.5%)
   gen split merge   : 744.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 711.00 ns  (0.2%)
   LB compute        : 271.97 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.78 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.702999258758393e-18,-4.858808667906889e-17,1.0857525815921587e-17)
    sum a = (-1.290374057605348e-17,-6.11229816760428e-17,-9.71293358242864e-18)
    sum e = 2.5920009147344514
    sum de = 9.690056916589196e-19
Info: CFL hydro = 0.008485556832792996 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008485556832792996 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9958e+04 |  512 |      1 | 2.565e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 995.4289092173643 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.306568034815295, dt = 0.008485556832792996 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.4%)
   patch tree reduce : 1954.00 ns (0.7%)
   gen split merge   : 681.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 784.00 ns  (0.3%)
   LB compute        : 274.93 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.465884243635813e-18,-4.9161846468748215e-17,1.144958151726161e-17)
    sum a = (-1.538612987017629e-17,1.0787854984317669e-16,-1.5319971853611225e-16)
    sum e = 2.592000981888505
    sum de = -5.21772295508649e-19
Info: CFL hydro = 0.009418814082917311 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009418814082917311 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9708e+04 |  512 |      1 | 2.598e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1175.8376484411006 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.315053591648088, dt = 0.009418814082917311 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1107.00 ns (0.4%)
   gen split merge   : 706.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 754.00 ns  (0.3%)
   LB compute        : 275.00 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1850.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.940114273880972e-18,-4.738641120119458e-17,9.394950637765798e-18)
    sum a = (-1.020355674952178e-16,3.8500452825829255e-17,-4.3693564391600327e-17)
    sum e = 2.59200103808396
    sum de = -1.6601845766184287e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011053487296275078
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.354333713879059e-18,-4.774793841560987e-17,9.849421083417409e-18)
    sum a = (6.297306426317206e-17,7.749269975709794e-17,6.215340742077302e-17)
    sum e = 2.5920007778356093
    sum de = -1.0909784360635388e-18
Info: CFL hydro = 0.005022591637874071 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005022591637874071 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4864e+04 |  512 |      1 | 3.445e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 984.3631304163865 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.324472405731005, dt = 0.005022591637874071 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.75 us    (1.5%)
   patch tree reduce : 1442.00 ns (0.5%)
   gen split merge   : 666.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1615.00 ns (0.5%)
   LB compute        : 294.16 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1991.00 ns (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.070692551764846e-18,-4.731176388161895e-17,1.085972132532087e-17)
    sum a = (1.803010865608634e-16,2.3465604459538268e-17,6.82657055883773e-18)
    sum e = 2.5920008510927386
    sum de = 2.371692252312041e-19
Info: CFL hydro = 0.007106686243480642 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007106686243480642 cfl multiplier : 0.6301369863013698        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9704e+04 |  512 |      1 | 2.599e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 695.8337286111963 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.329494997368879, dt = 0.007106686243480642 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.4%)
   patch tree reduce : 1245.00 ns (0.4%)
   gen split merge   : 1006.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 965.00 ns  (0.3%)
   LB compute        : 274.58 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1819.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.440892741030324e-18,-4.704976642663783e-17,1.0633217938961492e-17)
    sum a = (7.161458925875053e-17,1.0477556322552317e-16,2.2903554053321783e-17)
    sum e = 2.5920009280278444
    sum de = -9.994988777600744e-19
Info: CFL hydro = 0.008494734135506004 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008494734135506004 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7539e+04 |  512 |      1 | 2.919e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 876.4171763224381 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.33660168361236, dt = 0.008494734135506004 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.02 us    (1.5%)
   patch tree reduce : 1677.00 ns (0.5%)
   gen split merge   : 779.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 893.00 ns  (0.3%)
   LB compute        : 305.83 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.488462111348126e-18,-4.60983790202818e-17,1.0923391097900082e-17)
    sum a = (-1.1100495522775589e-16,-7.437800375598158e-17,-7.421407238750177e-17)
    sum e = 2.59200099532052
    sum de = 4.641740550953566e-19
Info: CFL hydro = 0.009420484278290732 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009420484278290732 cfl multiplier : 0.8356164383561643        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9316e+04 |  512 |      1 | 2.651e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1153.73338628033 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 5.345096417747866, dt = 0.009420484278290732 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.69 us    (1.5%)
   patch tree reduce : 1325.00 ns (0.4%)
   gen split merge   : 634.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 861.00 ns  (0.3%)
   LB compute        : 276.17 us  (90.4%)
   LB move op cnt    : 0
   LB apply          : 15.76 us   (5.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.039223583708454e-18,-4.7579616028331493e-17,9.756477852181088e-18)
    sum a = (2.2053452813919349e-16,-6.768023641523513e-17,3.782130858498434e-18)
    sum e = 2.592001046623108
    sum de = -5.04831636563563e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011244771474774476
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.6743485738207655e-18,-4.760449846819004e-17,1.0106844560483358e-17)
    sum a = (-2.6486625392951878e-17,-1.3091090711458975e-16,1.354775666650987e-17)
    sum e = 2.5920007781476015
    sum de = 1.2078689827846323e-18
Info: CFL hydro = 0.005020759038172975 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005020759038172975 cfl multiplier : 0.44520547945205474       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4814e+04 |  512 |      1 | 3.456e-02 | 0.0% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 981.2503042190215 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.354516902026157, dt = 0.005020759038172975 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 1479.00 ns (0.5%)
   gen split merge   : 802.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 285.03 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.713556356148121e-18,-4.836560839327486e-17,1.0162830050165078e-17)
    sum a = (3.6533276404071555e-18,3.957771610441085e-18,-3.4320202929594146e-17)
    sum e = 2.592000853823238
    sum de = -1.1011428314305904e-18
Info: CFL hydro = 0.0071076676735722065 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0071076676735722065 cfl multiplier : 0.6301369863013698       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9264e+04 |  512 |      1 | 2.658e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 680.0702835260689 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.35953766106433, dt = 0.0071076676735722065 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.4%)
   patch tree reduce : 1543.00 ns (0.5%)
   gen split merge   : 715.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 940.00 ns  (0.3%)
   LB compute        : 277.92 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.759820356049976e-18,-4.8099219919495173e-17,9.854909856915617e-18)
    sum a = (-3.135772891349475e-17,7.013920694243225e-17,-7.282065575542341e-17)
    sum e = 2.5920009286486083
    sum de = -1.7105830369800595e-18
Info: CFL hydro = 0.008501954048689638 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008501954048689638 cfl multiplier : 0.7534246575342465        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9744e+04 |  512 |      1 | 2.593e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 986.6969924078121 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.366645328737902, dt = 0.008501954048689638 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.49 us    (1.4%)
   patch tree reduce : 1234.00 ns (0.4%)
   gen split merge   : 742.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1593.00 ns (0.5%)
   LB compute        : 295.88 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1999.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.269752070633186e-18,-4.7133927620277015e-17,9.19936734211299e-18)
    sum a = (9.320669236423384e-17,-1.3020834410681914e-17,3.9261562750914083e-17)
    sum e = 2.5920009899164596
    sum de = 1.8905775382715984e-18
Info: CFL hydro = 0.00943644090472005 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00943644090472005 cfl multiplier : 0.8356164383561643         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9228e+04 |  512 |      1 | 2.663e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1149.4201972839019 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.375147282786592, dt = 0.00943644090472005 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.4%)
   patch tree reduce : 1352.00 ns (0.4%)
   gen split merge   : 631.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 924.00 ns  (0.3%)
   LB compute        : 295.86 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.47 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.823643212972019e-18,-4.7862470822605806e-17,9.985359707056357e-18)
    sum a = (2.2575691316362166e-17,2.927345865710862e-18,-5.79965762914636e-17)
    sum e = 2.5920010316575155
    sum de = -8.233160247311799e-19
Info: CFL hydro = 0.010063488088441444 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010063488088441444 cfl multiplier : 0.8904109589041095        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9440e+04 |  512 |      1 | 2.634e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1289.8626436176805 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.384583723691311, dt = 0.010063488088441444 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 2.08 us    (0.7%)
   gen split merge   : 768.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 277.11 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.73362732760141e-18,-4.790272182825933e-17,8.95035998441096e-18)
    sum a = (-6.175528838303634e-17,-1.1226956864174297e-16,-5.152128723651117e-17)
    sum e = 2.5920010544277217
    sum de = -1.2841019480375193e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010936858380836113
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.299336916150034e-18,-4.820332365684452e-17,8.925111626319205e-18)
    sum a = (-1.3114509478384661e-17,-5.36055574928973e-17,-5.148615908612264e-17)
    sum e = 2.592000776092264
    sum de = -2.2090619264392153e-18
Info: CFL hydro = 0.00523989930300612 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00523989930300612 cfl multiplier : 0.4634703196347032         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4534e+04 |  512 |      1 | 3.523e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1028.42349055921 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 5.394647211779753, dt = 0.00523989930300612 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.05 us    (1.7%)
   patch tree reduce : 1354.00 ns (0.5%)
   gen split merge   : 784.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 941.00 ns  (0.3%)
   LB compute        : 272.55 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 2.61 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1863.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.093690869083847e-18,-4.82530885365616e-17,8.736663736214068e-18)
    sum a = (-6.960057530314145e-17,9.517386878599154e-17,-1.868232131496672e-16)
    sum e = 2.5920008512311297
    sum de = 7.386127300057499e-19
Info: CFL hydro = 0.007259440459103712 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007259440459103712 cfl multiplier : 0.6423135464231354        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9771e+04 |  512 |      1 | 2.590e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 728.4182725297444 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.399887111082759, dt = 0.007259440459103712 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1193.00 ns (0.4%)
   gen split merge   : 700.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 785.00 ns  (0.3%)
   LB compute        : 275.89 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.652813929434621e-18,-4.709202998257403e-17,6.992697436716822e-18)
    sum a = (-1.15782383680596e-16,-1.8006689889160655e-16,4.964778588245622e-18)
    sum e = 2.592000912807613
    sum de = -9.75781955236954e-19
Info: CFL hydro = 0.008604110142538942 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008604110142538942 cfl multiplier : 0.7615423642820902        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9618e+04 |  512 |      1 | 2.610e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1001.3618687050933 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.407146551541862, dt = 0.008604110142538942 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.3%)
   patch tree reduce : 1065.00 ns (0.3%)
   gen split merge   : 666.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 814.00 ns  (0.3%)
   LB compute        : 294.96 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.893276740029598e-18,-4.9612291813834475e-17,7.783080820458754e-18)
    sum a = (-5.955392429202178e-17,-1.7165956156528495e-17,-1.8201065654643855e-16)
    sum e = 2.592000957314098
    sum de = -1.2874900798265365e-19
Info: CFL hydro = 0.009490708832877087 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009490708832877087 cfl multiplier : 0.8410282428547268        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9712e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1192.5580850113422 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.415750661684401, dt = 0.009490708832877087 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.85 us    (1.3%)
   patch tree reduce : 1280.00 ns (0.4%)
   gen split merge   : 627.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 777.00 ns  (0.3%)
   LB compute        : 273.25 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1900.00 ns (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.142101138615022e-18,-4.912671831835968e-17,5.226776043226744e-18)
    sum a = (6.054922188636346e-17,-5.847666101344018e-17,-3.127576322925485e-17)
    sum e = 2.5920009816103975
    sum de = 1.9244588561617704e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010803240385368595
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.619569901585632e-18,-4.933602354775801e-17,5.859814586686718e-18)
    sum a = (1.2200006629936588e-16,9.4166861808187e-17,7.485808847795816e-17)
    sum e = 2.592000775420906
    sum de = -2.778268066994105e-19
Info: CFL hydro = 0.005039050641465078 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005039050641465078 cfl multiplier : 0.44700941428490887       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4901e+04 |  512 |      1 | 3.436e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 994.3545056184956 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.425241370517278, dt = 0.005039050641465078 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.3%)
   patch tree reduce : 1133.00 ns (0.4%)
   gen split merge   : 651.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 918.00 ns  (0.3%)
   LB compute        : 290.26 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.75893021706664e-18,-4.8173135402604375e-17,6.844866470498423e-18)
    sum a = (1.1544281156017355e-16,7.330074047739999e-17,-3.780959920152149e-17)
    sum e = 2.592000833275592
    sum de = 5.21772295508649e-19
Info: CFL hydro = 0.007113122380901194 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007113122380901194 cfl multiplier : 0.6313396095232725        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9960e+04 |  512 |      1 | 2.565e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 707.1897411532498 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.430280421158743, dt = 0.007113122380901194 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.89 us    (1.3%)
   patch tree reduce : 1158.00 ns (0.4%)
   gen split merge   : 627.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 872.00 ns  (0.3%)
   LB compute        : 278.83 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1812.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.051976190497467e-18,-4.76879278253628e-17,6.23378302103128e-18)
    sum a = (1.6366205266016288e-16,7.814842523101717e-17,-3.4929090869662004e-17)
    sum e = 2.5920008826661562
    sum de = 2.439454888092385e-19
Info: CFL hydro = 0.00849253406147651 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00849253406147651 cfl multiplier : 0.7542264063488483         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9604e+04 |  512 |      1 | 2.612e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 980.4744549402495 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.4373935435396445, dt = 0.00849253406147651 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.96 us    (1.4%)
   patch tree reduce : 947.00 ns  (0.3%)
   gen split merge   : 522.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 749.00 ns  (0.3%)
   LB compute        : 268.06 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1808.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.395098430505119e-18,-4.7092212941690635e-17,5.889819881810254e-18)
    sum a = (-1.3532534468008172e-16,1.2714048563955416e-16,-1.2646134139870924e-17)
    sum e = 2.592000917828734
    sum de = 1.5043305143236374e-18
Info: CFL hydro = 0.009410463918313213 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009410463918313213 cfl multiplier : 0.836150937565899         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9528e+04 |  512 |      1 | 2.622e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1166.0499776373706 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.445886077601121, dt = 0.009410463918313213 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.10 us    (1.7%)
   patch tree reduce : 1174.00 ns (0.4%)
   gen split merge   : 640.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 938.00 ns  (0.3%)
   LB compute        : 279.00 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1968.00 ns (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.044346438973448e-18,-4.564317673816376e-17,5.8883562088773986e-18)
    sum a = (-6.916732811501625e-17,-1.4447037316456245e-16,-4.3394975113297817e-17)
    sum e = 2.5920009376619935
    sum de = -6.911788849595091e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010497677093389961
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.862850995299376e-18,-4.7092212941690635e-17,5.75662564492041e-18)
    sum a = (-9.639164466612727e-17,-9.072430307011103e-17,-4.613497084360318e-17)
    sum e = 2.5920007756498307
    sum de = -1.9109063290057016e-18
Info: CFL hydro = 0.005012151719585549 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005012151719585549 cfl multiplier : 0.4453836458552997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4557e+04 |  512 |      1 | 3.517e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 963.1684172848411 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.455296541519434, dt = 0.005012151719585549 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.5%)
   patch tree reduce : 1230.00 ns (0.4%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 921.00 ns  (0.3%)
   LB compute        : 273.81 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.332690006745968e-18,-4.703952071610784e-17,5.507801246334987e-18)
    sum a = (1.4279593132937583e-17,-6.866382462611398e-17,-9.525583447023145e-17)
    sum e = 2.5920008212567573
    sum de = -1.1519648082658485e-18
Info: CFL hydro = 0.007092415510405325 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007092415510405325 cfl multiplier : 0.6302557639035332        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9428e+04 |  512 |      1 | 2.635e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 684.6707110456188 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.4603086932390195, dt = 0.007092415510405325 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.98 us    (1.7%)
   patch tree reduce : 1335.00 ns (0.5%)
   gen split merge   : 727.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 998.00 ns  (0.3%)
   LB compute        : 278.45 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.41 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1999.00 ns (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.969699119397821e-18,-4.7458131174904493e-17,4.6983901144659336e-18)
    sum a = (-5.920264278813647e-17,9.899112779487851e-17,-3.8196008855795326e-17)
    sum e = 2.592000861759671
    sum de = 1.5449880957918438e-18
Info: CFL hydro = 0.008476847329696995 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008476847329696995 cfl multiplier : 0.7535038426023556        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9718e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 983.3219492666831 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.467401108749425, dt = 0.008476847329696995 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1054.00 ns (0.3%)
   gen split merge   : 699.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 854.00 ns  (0.3%)
   LB compute        : 286.11 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.681044164765561e-18,-4.618473572332027e-17,4.588614644501776e-18)
    sum a = (5.441057760596779e-17,1.1824135420779314e-16,-3.513985977199319e-17)
    sum e = 2.592000893017713
    sum de = 5.285485590866834e-19
Info: CFL hydro = 0.009399132295893266 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009399132295893266 cfl multiplier : 0.8356692284015704        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0216e+04 |  512 |      1 | 2.533e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1204.9397681906225 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.475877956079122, dt = 0.009399132295893266 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.76 us    (1.4%)
   patch tree reduce : 1435.00 ns (0.4%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 314.02 us  (94.9%)
   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.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.903833837419328e-18,-4.505478021915588e-17,4.376382069237739e-18)
    sum a = (2.6395877671114843e-17,7.201270829648721e-17,-1.1414306999579792e-16)
    sum e = 2.5920009153603742
    sum de = 1.395910297075087e-18
Info: CFL hydro = 0.010003871040833362 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010003871040833362 cfl multiplier : 0.8904461522677135        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9832e+04 |  512 |      1 | 2.582e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1310.6343965151164 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.485277088375016, dt = 0.010003871040833362 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.3%)
   patch tree reduce : 1570.00 ns (0.5%)
   gen split merge   : 674.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 291.02 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.590607829788265e-18,-4.435221721138527e-17,2.8248887604109818e-18)
    sum a = (1.2228987354007125e-16,3.6931395441808235e-17,-6.821886805452592e-17)
    sum e = 2.5920009326471107
    sum de = -5.421010862427522e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011566425486432113
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.068076592758877e-18,-4.4683007294210596e-17,2.955155651435115e-18)
    sum a = (5.691053097528487e-17,-1.172343472299886e-16,3.0444397003392963e-19)
    sum e = 2.592000778613465
    sum de = 1.3688052427629493e-18
Info: CFL hydro = 0.00520331142659025 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00520331142659025 cfl multiplier : 0.4634820507559045         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5046e+04 |  512 |      1 | 3.403e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1058.3136674927362 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.495280959415849, dt = 0.0047190405841508465 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1119.00 ns (0.4%)
   gen split merge   : 724.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 888.00 ns  (0.3%)
   LB compute        : 280.64 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1831.00 ns (64.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.293482224418612e-18,-4.5906637866077736e-17,3.388402839560323e-18)
    sum a = (-7.420821769577034e-18,-9.580617549298509e-17,4.927308561164523e-17)
    sum e = 2.5920008120161304
    sum de = 9.351243737687476e-19
Info: CFL hydro = 0.007208692576827154 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007208692576827154 cfl multiplier : 0.6423213671706031        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9846e+04 |  512 |      1 | 2.580e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 658.4969659236467 (tsim/hr)                             [sph::Model][rank=0]
Info: iteration since start : 744                                                     [SPH][rank=0]
Info: time since start : 1758.0239598280002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14981055381067165 max=0.15021644899815909 delta=0.0004058951874874317
Number of particle pairs: 130816
Distance min=0.146725 max=1.920958 mean=0.806435
---------------- t = 5.5, dt = 0.007208692576827154 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.84 us    (1.8%)
   patch tree reduce : 1417.00 ns (0.3%)
   gen split merge   : 471.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 786.00 ns  (0.1%)
   LB compute        : 516.32 us  (95.6%)
   LB move op cnt    : 0
   LB apply          : 4.40 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (79.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.36812954399424e-18,-4.663847433250545e-17,3.804085952491265e-18)
    sum a = (-1.622686360280845e-16,-9.956488758455783e-17,2.112372776696958e-17)
    sum e = 2.59200085958261
    sum de = -1.3417001884508117e-18
Info: CFL hydro = 0.008543753172770969 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008543753172770969 cfl multiplier : 0.7615475781137354        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4700e+04 |  512 |      1 | 3.483e-02 | 0.1% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 745.082792706125 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 5.507208692576827, dt = 0.008543753172770969 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.4%)
   patch tree reduce : 1117.00 ns (0.4%)
   gen split merge   : 759.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 919.00 ns  (0.3%)
   LB compute        : 301.85 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.188938672466396e-18,-4.740251160345599e-17,3.981190377366772e-18)
    sum a = (2.1779453240888813e-17,7.027971954398638e-17,6.436648089525044e-17)
    sum e = 2.5920008977675373
    sum de = 2.303929616531697e-19
Info: CFL hydro = 0.00943392347867346 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00943392347867346 cfl multiplier : 0.8410317187424902         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9595e+04 |  512 |      1 | 2.613e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1177.164566759797 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.515752445749598, dt = 0.00943392347867346 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.5%)
   patch tree reduce : 1235.00 ns (0.4%)
   gen split merge   : 699.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1489.00 ns (0.5%)
   LB compute        : 277.87 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1887.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.275606762364606e-18,-4.599445824204906e-17,4.862321482945742e-18)
    sum a = (-9.75860017793373e-17,1.6228620010327877e-16,-7.906175714111896e-17)
    sum e = 2.5920009340455246
    sum de = 8.267041565201971e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010994409622470289
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.71031762342267e-18,-4.565195877576089e-17,4.1539037834437134e-18)
    sum a = (4.8031890964583825e-17,5.515705080172406e-17,-4.8980351025074144e-17)
    sum e = 2.592000782220068
    sum de = -1.0570971181733668e-18
Info: CFL hydro = 0.0050155020510513695 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0050155020510513695 cfl multiplier : 0.44701057291416335      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4849e+04 |  512 |      1 | 3.448e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 984.9494156933998 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.525186369228272, dt = 0.0050155020510513695 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1194.00 ns (0.4%)
   gen split merge   : 759.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 887.00 ns  (0.3%)
   LB compute        : 273.37 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1935.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.881878743426496e-18,-4.573685180586651e-17,3.954844264575374e-18)
    sum a = (4.1310704856911684e-17,-4.840073654366339e-17,-7.593535175653976e-18)
    sum e = 2.5920008242804387
    sum de = -7.453889935837843e-19
Info: CFL hydro = 0.007084827247289945 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007084827247289945 cfl multiplier : 0.6313403819427755        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9612e+04 |  512 |      1 | 2.611e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 691.6370392817306 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.530201871279323, dt = 0.007084827247289945 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.3%)
   patch tree reduce : 1501.00 ns (0.5%)
   gen split merge   : 626.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1761.00 ns (0.6%)
   LB compute        : 286.55 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.580362119258277e-18,-4.663847433250545e-17,4.1421943999808695e-18)
    sum a = (8.887422048298176e-18,-2.4940986775856545e-18,-1.6305316472009502e-16)
    sum e = 2.592000874416722
    sum de = 9.215718466126788e-19
Info: CFL hydro = 0.008467124986325611 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008467124986325611 cfl multiplier : 0.7542269212951836        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0205e+04 |  512 |      1 | 2.534e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1006.4975682520449 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.537286698526613, dt = 0.008467124986325611 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1346.00 ns (0.5%)
   gen split merge   : 671.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 842.00 ns  (0.3%)
   LB compute        : 274.06 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1954.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.652082092968194e-18,-4.642477808430856e-17,2.0637788353261577e-18)
    sum a = (3.474174073425651e-17,-4.0289061149778593e-17,-3.898639223953726e-17)
    sum e = 2.592000925915364
    sum de = -1.8431436932253575e-18
Info: CFL hydro = 0.009393379752166971 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009393379752166971 cfl multiplier : 0.8361512808634558        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9333e+04 |  512 |      1 | 2.648e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1150.9941362806828 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.545753823512939, dt = 0.009393379752166971 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.6%)
   patch tree reduce : 1398.00 ns (0.5%)
   gen split merge   : 692.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 887.00 ns  (0.3%)
   LB compute        : 274.32 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1903.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.180779408588744e-18,-4.6913644843882274e-17,2.1545265571631944e-18)
    sum a = (-2.882850208552057e-17,-1.0442428172163787e-16,-2.0784155646547118e-18)
    sum e = 2.592000976743455
    sum de = 6.776263578034403e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01069180796999662
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.596462521519687e-18,-4.714490516727343e-17,2.3243126173744243e-18)
    sum a = (-2.1217402834672327e-17,1.7534069899141636e-16,-1.3319423688984422e-18)
    sum e = 2.5920007862410035
    sum de = -5.285485590866834e-19
Info: CFL hydro = 0.005009476655283585 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005009476655283585 cfl multiplier : 0.44538376028781856       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4706e+04 |  512 |      1 | 3.481e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 971.3192273811026 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.555147203265106, dt = 0.005009476655283585 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1277.00 ns (0.4%)
   gen split merge   : 712.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1079.00 ns (0.4%)
   LB compute        : 280.14 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.600121703851825e-18,-4.5048925527424453e-17,2.3623681136286658e-18)
    sum a = (-6.538519725651781e-17,1.348628240332994e-16,3.1395784409748993e-17)
    sum e = 2.5920008394772824
    sum de = 4.743384504624082e-19
Info: CFL hydro = 0.007093479903458529 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007093479903458529 cfl multiplier : 0.6302558401918791        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0035e+04 |  512 |      1 | 2.556e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 705.6973388298994 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.560156679920389, dt = 0.007093479903458529 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.5%)
   patch tree reduce : 1328.00 ns (0.5%)
   gen split merge   : 739.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 964.00 ns  (0.3%)
   LB compute        : 276.03 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1786.00 ns (64.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.179736185262576e-18,-4.4243905414353965e-17,2.6463206626026194e-18)
    sum a = (-3.522182545623309e-17,5.683734732864209e-17,4.012366610836593e-17)
    sum e = 2.592000904077703
    sum de = 9.893344823930228e-19
Info: CFL hydro = 0.00848976884935543 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00848976884935543 cfl multiplier : 0.7535038934612528         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9930e+04 |  512 |      1 | 2.569e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 994.0391059442435 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.567250159823848, dt = 0.00848976884935543 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 2.22 us    (0.8%)
   gen split merge   : 779.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1038.00 ns (0.4%)
   LB compute        : 272.19 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1848.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.374404685332349e-18,-4.3918970023260064e-17,3.012238895816477e-18)
    sum a = (5.154470600343686e-17,7.703603380204705e-17,-2.3093465616359777e-17)
    sum e = 2.592000969487811
    sum de = 9.147955830346444e-19
Info: CFL hydro = 0.009429675279079426 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009429675279079426 cfl multiplier : 0.8356692623075018        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9732e+04 |  512 |      1 | 2.595e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1177.862452784579 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.575739928673204, dt = 0.009429675279079426 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.3%)
   patch tree reduce : 1449.00 ns (0.5%)
   gen split merge   : 1090.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 1012.00 ns (0.3%)
   LB compute        : 288.29 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.390084637987071e-18,-4.3119804601920995e-17,2.5262994821084737e-18)
    sum a = (5.641580952397974e-17,3.533891929086153e-17,-1.6135823146384843e-16)
    sum e = 2.5920010309591155
    sum de = -5.827586677109586e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010755364577791348
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.509373982014788e-18,-4.3351064925312157e-17,1.93497561723488e-18)
    sum a = (-4.730590918988753e-17,-9.143857546134448e-17,-4.136193340956162e-17)
    sum e = 2.5920007894421
    sum de = 1.8905775382715984e-18
Info: CFL hydro = 0.0050341123096747905 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0050341123096747905 cfl multiplier : 0.4452230874358339       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4613e+04 |  512 |      1 | 3.504e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 968.8857879181288 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.585169603952283, dt = 0.0050341123096747905 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.5%)
   patch tree reduce : 1527.00 ns (0.5%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1044.00 ns (0.3%)
   LB compute        : 288.39 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1951.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.216328008583962e-18,-4.4264396835413943e-17,2.3389493467029788e-18)
    sum a = (9.777335191474278e-17,5.990520579590708e-17,3.9200088487734154e-17)
    sum e = 2.592000857352674
    sum de = 5.89534931288993e-19
Info: CFL hydro = 0.007132886801793195 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007132886801793195 cfl multiplier : 0.6301487249572225        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9576e+04 |  512 |      1 | 2.615e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 692.9292471119604 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.590203716261958, dt = 0.007132886801793195 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.0%)
   patch tree reduce : 1176.00 ns (0.3%)
   gen split merge   : 723.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1006.00 ns (0.2%)
   LB compute        : 441.96 us  (96.3%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.277015903923988e-18,-4.357354321110618e-17,2.7868332641567407e-18)
    sum a = (-3.660353270484862e-17,-4.601787700897475e-17,-3.5602380418775506e-17)
    sum e = 2.59200093545099
    sum de = -6.301925127571995e-19
Info: CFL hydro = 0.00854219745430135 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00854219745430135 cfl multiplier : 0.7534324833048149         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9446e+04 |  512 |      1 | 2.633e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 975.2814292799219 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.597336603063751, dt = 0.00854219745430135 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.4%)
   patch tree reduce : 1205.00 ns (0.4%)
   gen split merge   : 1052.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 1274.00 ns (0.4%)
   LB compute        : 272.28 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1895.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.870809716871776e-18,-4.4258542143682525e-17,2.142817173700351e-18)
    sum a = (1.4191772756966257e-17,1.5136720002417725e-16,-3.6995797050853874e-17)
    sum e = 2.5920010099032837
    sum de = -1.5382118322138094e-18
Info: CFL hydro = 0.0094779571457364 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0094779571457364 cfl multiplier : 0.8356216555365433          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9701e+04 |  512 |      1 | 2.599e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1183.2642741953891 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.605878800518052, dt = 0.0094779571457364 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.5%)
   patch tree reduce : 1071.00 ns (0.4%)
   gen split merge   : 686.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1140.00 ns (0.4%)
   LB compute        : 288.44 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (64.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.548618712526974e-18,-4.198545807895804e-17,1.8471552412635538e-18)
    sum a = (1.1030239221998528e-17,-1.1173093700245219e-16,-4.587736440742063e-17)
    sum e = 2.5920010726104246
    sum de = 7.047314121155779e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010752455220917743
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.65912601895756e-18,-4.322665272601944e-17,1.8266638202035778e-18)
    sum a = (-1.8126125600481657e-17,-1.484984010757806e-16,-1.6254380653946132e-16)
    sum e = 2.5920007908388634
    sum de = 1.9481757786848908e-19
Info: CFL hydro = 0.005048731275035348 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005048731275035348 cfl multiplier : 0.44520721851218115       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4573e+04 |  512 |      1 | 3.513e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 971.152498672334 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 5.615356757663789, dt = 0.005048731275035348 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.94 us    (1.7%)
   patch tree reduce : 1167.00 ns (0.4%)
   gen split merge   : 874.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1037.00 ns (0.4%)
   LB compute        : 276.89 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1959.00 ns (64.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.869254564380618e-18,-4.412827525265839e-17,3.776276166767012e-19)
    sum a = (-4.02100228114044e-17,-6.730553614442414e-17,8.231696574378943e-18)
    sum e = 2.5920008700195054
    sum de = 1.5670109524204556e-19
Info: CFL hydro = 0.0071421279058982105 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0071421279058982105 cfl multiplier : 0.6301381456747874       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9852e+04 |  512 |      1 | 2.579e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 704.7122039417367 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.620405488938824, dt = 0.0071421279058982105 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.6%)
   patch tree reduce : 1092.00 ns (0.4%)
   gen split merge   : 693.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 904.00 ns  (0.3%)
   LB compute        : 274.23 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1830.00 ns (64.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.21047331685254e-18,-4.451322123399937e-17,8.986951807732346e-19)
    sum a = (-1.3606303583824086e-17,-3.615857613326057e-17,1.0889726620444407e-18)
    sum e = 2.5920009532938035
    sum de = -4.277516383634217e-20
Info: CFL hydro = 0.008534122819156484 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008534122819156484 cfl multiplier : 0.7534254304498583        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0150e+04 |  512 |      1 | 2.541e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1011.8736734767241 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.627547616844723, dt = 0.008534122819156484 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.70 us    (1.6%)
   patch tree reduce : 919.00 ns  (0.3%)
   gen split merge   : 601.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 810.00 ns  (0.3%)
   LB compute        : 272.52 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1789.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.196934342223627e-18,-4.471081707993485e-17,8.503939739890054e-19)
    sum a = (-9.929557176491244e-18,3.1451403981197503e-17,1.6276043013352393e-17)
    sum e = 2.592001025258478
    sum de = 3.1679032227310833e-19
Info: CFL hydro = 0.009459612406454326 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009459612406454326 cfl multiplier : 0.835616953633239         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0195e+04 |  512 |      1 | 2.535e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1211.8038397676257 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.636081739663879, dt = 0.009459612406454326 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.84 us    (1.2%)
   patch tree reduce : 1155.00 ns (0.4%)
   gen split merge   : 594.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 750.00 ns  (0.2%)
   LB compute        : 295.42 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.300489202223149e-18,-4.4060946297747036e-17,1.1372738688286698e-18)
    sum a = (8.039662685588312e-17,3.3980630809171685e-17,5.439008618490781e-17)
    sum e = 2.592001077997745
    sum de = 1.362028979184915e-18
Info: CFL hydro = 0.010075596495346563 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010075596495346563 cfl multiplier : 0.8904113024221593        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0027e+04 |  512 |      1 | 2.556e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1332.0825835557796 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.6455413520703335, dt = 0.010075596495346563 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.3%)
   patch tree reduce : 1342.00 ns (0.4%)
   gen split merge   : 1078.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 835.00 ns  (0.3%)
   LB compute        : 286.60 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.03148476943749e-18,-4.3680391335204625e-17,1.895456448047783e-18)
    sum a = (6.419084014330779e-17,2.9765252762548045e-17,-3.7821308584984334e-17)
    sum e = 2.592001110173603
    sum de = 8.605854744103691e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010517887923348094
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.008797838978231e-18,-4.368478235400319e-17,1.4212264178026234e-18)
    sum a = (2.6439787859100506e-17,7.374569704898803e-17,1.3086406958073838e-16)
    sum e = 2.5920007896997044
    sum de = 7.013432803265607e-19
Info: CFL hydro = 0.005244017706658559 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005244017706658559 cfl multiplier : 0.4634704341407197        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4742e+04 |  512 |      1 | 3.473e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1044.3513347859032 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.65561694856568, dt = 0.005244017706658559 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.3%)
   patch tree reduce : 1292.00 ns (0.4%)
   gen split merge   : 13.41 us   (4.4%)
   split / merge op  : 0/0
   apply split merge : 1346.00 ns (0.4%)
   LB compute        : 278.11 us  (90.4%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.174924716857322e-18,-4.306784421280463e-17,3.009311549950766e-18)
    sum a = (-9.911993101296979e-17,3.91327595328228e-17,-1.0978717934762016e-16)
    sum e = 2.592000876103192
    sum de = -2.710505431213761e-20
Info: CFL hydro = 0.007267304390315474 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007267304390315474 cfl multiplier : 0.6423136227604798        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9946e+04 |  512 |      1 | 2.567e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 735.4419436246764 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.660860966272339, dt = 0.007267304390315474 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.08 us    (1.4%)
   patch tree reduce : 1133.00 ns (0.4%)
   gen split merge   : 662.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 943.00 ns  (0.3%)
   LB compute        : 277.75 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.345863063141668e-18,-4.292586793831765e-17,1.5207561772367928e-18)
    sum a = (6.436648089525044e-17,-1.610040226140974e-16,8.166124026987021e-17)
    sum e = 2.592000949167149
    sum de = -1.0638733817514012e-18
Info: CFL hydro = 0.008616932518938 sink sink = inf                                   [SPH][rank=0]
Info: cfl dt = 0.008616932518938 cfl multiplier : 0.7615424151736532           [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9808e+04 |  512 |      1 | 2.585e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1012.1600123683033 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.668128270662654, dt = 0.008616932518938 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.5%)
   patch tree reduce : 1194.00 ns (0.4%)
   gen split merge   : 662.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1388.00 ns (0.5%)
   LB compute        : 274.43 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1983.00 ns (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.104668416080262e-18,-4.49947696289088e-17,2.9976021664879226e-18)
    sum a = (8.800772610673135e-17,4.1615148826945613e-17,-6.438989966217611e-17)
    sum e = 2.5920010030131233
    sum de = -8.876905287225068e-19
Info: CFL hydro = 0.009517465553061984 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009517465553061984 cfl multiplier : 0.8410282767824354        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9788e+04 |  512 |      1 | 2.587e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1198.8840082339686 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.676745203181592, dt = 0.009517465553061984 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.4%)
   patch tree reduce : 1355.00 ns (0.5%)
   gen split merge   : 661.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 791.00 ns  (0.3%)
   LB compute        : 272.63 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1752.00 ns (63.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.184018141314196e-18,-4.386774147061012e-17,1.756407519426517e-18)
    sum a = (3.3559093004509324e-17,-4.997564861941584e-17,2.768098250616191e-17)
    sum e = 2.592001032722774
    sum de = 1.8973538018496328e-19
Info: CFL hydro = 0.010101045921833508 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010101045921833508 cfl multiplier : 0.8940188511882902        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9913e+04 |  512 |      1 | 2.571e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1332.5412388459847 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.686262668734654, dt = 0.010101045921833508 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.6%)
   patch tree reduce : 1301.00 ns (0.4%)
   gen split merge   : 804.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1049.00 ns (0.4%)
   LB compute        : 272.88 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.9176296675345075e-18,-4.474429859827392e-17,2.4750709294585336e-18)
    sum a = (2.8922177153223315e-18,8.374551052625633e-17,-1.833689450281284e-16)
    sum e = 2.592001039894798
    sum de = 3.8624702394796095e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010357836699160065
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.1327895886642556e-18,-4.402179304679316e-17,1.368534192219828e-18)
    sum a = (3.169730103391721e-17,3.9179597066674176e-17,5.5572733914655e-17)
    sum e = 2.59200078424048
    sum de = -1.294266343404571e-18
Info: CFL hydro = 0.00524150619169788 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00524150619169788 cfl multiplier : 0.4646729503960967         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4274e+04 |  512 |      1 | 3.587e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1013.7783559823715 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.696363714656487, dt = 0.00524150619169788 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.3%)
   patch tree reduce : 1338.00 ns (0.4%)
   gen split merge   : 866.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 925.00 ns  (0.3%)
   LB compute        : 300.29 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.97764025778158e-18,-4.4095662790123205e-17,2.8483075273366688e-18)
    sum a = (6.415571199291925e-17,-2.458970527197124e-18,-1.6685871434551913e-16)
    sum e = 2.592000853193543
    sum de = 9.622294280808852e-19
Info: CFL hydro = 0.0072482604469103476 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0072482604469103476 cfl multiplier : 0.6431153002640645       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9717e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 726.6526719209987 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.701605220848185, dt = 0.0072482604469103476 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.5%)
   patch tree reduce : 1422.00 ns (0.5%)
   gen split merge   : 810.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1060.00 ns (0.4%)
   LB compute        : 276.15 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1882.00 ns (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.3877800658408415e-18,-4.420850282529053e-17,1.0662857315851814e-18)
    sum a = (-5.404465937275393e-17,7.107595761945972e-17,1.3231603313013095e-17)
    sum e = 2.5920009036224427
    sum de = 5.014435047745458e-19
Info: CFL hydro = 0.008580101312185019 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008580101312185019 cfl multiplier : 0.7620768668427097        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9958e+04 |  512 |      1 | 2.565e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1017.131974293411 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.708853481295095, dt = 0.008580101312185019 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.88 us    (1.4%)
   patch tree reduce : 1235.00 ns (0.4%)
   gen split merge   : 693.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 269.19 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1819.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.302575648875486e-18,-4.3362408390541786e-17,1.7754352675536377e-18)
    sum a = (-7.142723912334503e-19,-9.390925537200445e-17,-4.170882389464836e-17)
    sum e = 2.5920009353137266
    sum de = -1.2739375526704677e-18
Info: CFL hydro = 0.00946302976163712 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00946302976163712 cfl multiplier : 0.8413845778951398         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0693e+04 |  512 |      1 | 2.474e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1248.380877602286 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.7174335826072795, dt = 0.00946302976163712 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.5%)
   patch tree reduce : 1155.00 ns (0.4%)
   gen split merge   : 841.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 946.00 ns  (0.3%)
   LB compute        : 261.47 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.38 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.06106961495434e-18,-4.48414498891922e-17,1.2111893519378692e-18)
    sum a = (5.451962123946552e-17,1.1674255312454917e-16,-3.086593480805533e-17)
    sum e = 2.592000947680793
    sum de = 1.7618285302889447e-19
Info: CFL hydro = 0.010048275496922113 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010048275496922113 cfl multiplier : 0.8942563852634265        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0348e+04 |  512 |      1 | 2.516e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1353.908267423251 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.7268966123689165, dt = 0.010048275496922113 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.4%)
   patch tree reduce : 1340.00 ns (0.4%)
   gen split merge   : 968.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 932.00 ns  (0.3%)
   LB compute        : 283.87 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.371679663579432e-18,-4.278608717322996e-17,9.920043302427684e-19)
    sum a = (6.323067069935462e-19,-1.9891900626678449e-16,-8.236380327764082e-17)
    sum e = 2.592000946293827
    sum de = -3.1170812458958252e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01116120095059868
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.665877923083373e-18,-4.431416171513103e-17,6.58652819784944e-19)
    sum a = (-9.635651651573873e-17,2.941397125866274e-17,-1.50114295993653e-17)
    sum e = 2.5920007809435326
    sum de = 1.6534083130403943e-18
Info: CFL hydro = 0.005219102730527818 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005219102730527818 cfl multiplier : 0.46475212842114216       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5055e+04 |  512 |      1 | 3.401e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1063.6370465415955 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.736944887865839, dt = 0.005219102730527818 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.04 us    (1.7%)
   patch tree reduce : 1145.00 ns (0.4%)
   gen split merge   : 664.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 994.00 ns  (0.3%)
   LB compute        : 277.93 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1948.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.582137179050873e-18,-4.307077155867034e-17,9.565102616210242e-19)
    sum a = (-2.904512567958317e-17,3.814917132194395e-17,-9.147370361173302e-17)
    sum e = 2.5920008255213394
    sum de = -5.55653613398821e-19
Info: CFL hydro = 0.007220559319938721 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007220559319938721 cfl multiplier : 0.6431680856140948        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0526e+04 |  512 |      1 | 2.494e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 753.250457658685 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 5.742163990596366, dt = 0.007220559319938721 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.88 us    (1.3%)
   patch tree reduce : 1753.00 ns (0.6%)
   gen split merge   : 766.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 864.00 ns  (0.3%)
   LB compute        : 277.59 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.41966948350392e-18,-4.2816092468353495e-17,1.9759584593548318e-20)
    sum a = (1.0371586402213584e-16,1.0772632785815972e-18,5.237607222929874e-17)
    sum e = 2.5920008577828875
    sum de = 1.0842021724855044e-19
Info: CFL hydro = 0.008553611142546986 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008553611142546986 cfl multiplier : 0.7621120570760631        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0402e+04 |  512 |      1 | 2.510e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1035.7766550384345 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.749384549916305, dt = 0.008553611142546986 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.81 us    (1.3%)
   patch tree reduce : 1307.00 ns (0.5%)
   gen split merge   : 638.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 877.00 ns  (0.3%)
   LB compute        : 272.45 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.67 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1927.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.232630734958166e-18,-4.29719736357026e-17,1.0794587879808804e-18)
    sum a = (-1.9203388879063254e-18,6.052580311943778e-17,9.244558243914902e-17)
    sum e = 2.592000879872669
    sum de = -5.285485590866834e-19
Info: CFL hydro = 0.009442505212573674 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009442505212573674 cfl multiplier : 0.8414080380507087        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0343e+04 |  512 |      1 | 2.517e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1223.462027350002 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.757938161058853, dt = 0.009442505212573674 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.87 us    (1.4%)
   patch tree reduce : 1337.00 ns (0.5%)
   gen split merge   : 671.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 728.00 ns  (0.3%)
   LB compute        : 266.68 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.6292860997619875e-18,-4.214646210157214e-17,2.0248085434888816e-18)
    sum a = (9.674292617001256e-17,-3.8219427622721014e-17,2.3746629662646512e-17)
    sum e = 2.592000893760545
    sum de = 7.995991022080595e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011030866188567169
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.24726746428672e-18,-4.254604481224167e-17,1.7137780452571027e-18)
    sum a = (-3.543259435856427e-17,-1.2808894570004448e-16,-1.6658939852587374e-16)
    sum e = 2.5920007833039738
    sum de = -6.505213034913027e-19
Info: CFL hydro = 0.005019110727205433 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005019110727205433 cfl multiplier : 0.44713601268356956       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4840e+04 |  512 |      1 | 3.450e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 985.2692792601157 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.767380666271427, dt = 0.005019110727205433 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.5%)
   patch tree reduce : 1300.00 ns (0.4%)
   gen split merge   : 693.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 966.00 ns  (0.3%)
   LB compute        : 277.29 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1987.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.0537512502900624e-18,-4.366868195174178e-17,9.559613842712034e-20)
    sum a = (-9.718788274160061e-17,-8.527943975988883e-17,1.3766722137265043e-16)
    sum e = 2.5920008140610693
    sum de = 1.2197274440461925e-18
Info: CFL hydro = 0.007088754981425988 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007088754981425988 cfl multiplier : 0.631424008455713         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6873e+04 |  512 |      1 | 3.034e-02 | 0.0% |   1.5% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 595.4724088592135 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.772399776998632, dt = 0.007088754981425988 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1808.00 ns (0.6%)
   gen split merge   : 1036.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 824.00 ns  (0.3%)
   LB compute        : 279.64 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.038803134101767e-18,-4.4159012384248355e-17,1.7983051571295038e-18)
    sum a = (1.8805269841326578e-17,6.447772003814745e-17,4.4308307023399603e-17)
    sum e = 2.5920008440649127
    sum de = 1.3552527156068805e-19
Info: CFL hydro = 0.008470876978272498 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008470876978272498 cfl multiplier : 0.7542826723038086        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9989e+04 |  512 |      1 | 2.561e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 996.3208803025732 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.779488531980058, dt = 0.008470876978272498 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.4%)
   patch tree reduce : 1131.00 ns (0.4%)
   gen split merge   : 950.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 852.00 ns  (0.3%)
   LB compute        : 272.31 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1925.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.276229536084088e-18,-4.312858663951813e-17,1.7560416011933034e-18)
    sum a = (1.6356837759246013e-16,2.2411759947882358e-17,3.961284425479938e-17)
    sum e = 2.5920008716492062
    sum de = 1.043544591017298e-18
Info: CFL hydro = 0.009396269491320037 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009396269491320037 cfl multiplier : 0.836188448202539         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9917e+04 |  512 |      1 | 2.571e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1186.2576377183168 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.78795940895833, dt = 0.009396269491320037 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1276.00 ns (0.4%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 875.00 ns  (0.3%)
   LB compute        : 287.07 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.0960887025959236e-18,-4.2974900981568307e-17,2.013648037375859e-18)
    sum a = (-1.0285522433761685e-16,-9.61340382299447e-17,3.317268335023549e-17)
    sum e = 2.592000898256563
    sum de = 8.131516293641283e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011308638148918958
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.4053441410351066e-18,-4.343010326368635e-17,2.042555577799754e-18)
    sum a = (1.6791255885717505e-16,-5.141590278534558e-17,1.7294759374619772e-17)
    sum e = 2.5920007869812434
    sum de = 4.0657581468206416e-19
Info: CFL hydro = 0.0050084353670916655 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0050084353670916655 cfl multiplier : 0.4453961494008463       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4979e+04 |  512 |      1 | 3.418e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 989.6473262155993 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.79735567844965, dt = 0.0050084353670916655 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.4%)
   patch tree reduce : 1092.00 ns (0.4%)
   gen split merge   : 698.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 967.00 ns  (0.3%)
   LB compute        : 282.18 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.2778955331297375e-18,-4.356037015471048e-17,1.9788858052205426e-18)
    sum a = (-9.088823443859084e-17,2.949447326996979e-17,-2.0468002293050346e-17)
    sum e = 2.5920008178688514
    sum de = -3.2526065174565133e-19
Info: CFL hydro = 0.007086458412087761 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007086458412087761 cfl multiplier : 0.6302640996005642        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9800e+04 |  512 |      1 | 2.586e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 697.2579149547521 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.802364113816742, dt = 0.007086458412087761 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.3%)
   patch tree reduce : 1311.00 ns (0.4%)
   gen split merge   : 667.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 929.00 ns  (0.3%)
   LB compute        : 303.34 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.416633074891263e-18,-4.307003972220391e-17,1.8581327882599696e-18)
    sum a = (3.494080025312485e-17,-7.609781945208672e-17,4.2235746150476315e-17)
    sum e = 2.592000855817785
    sum de = 1.531435568635775e-18
Info: CFL hydro = 0.008472134910061222 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008472134910061222 cfl multiplier : 0.7535093997337095        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0073e+04 |  512 |      1 | 2.551e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1000.16027982713 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 5.80945057222883, dt = 0.008472134910061222 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.91 us    (1.3%)
   patch tree reduce : 1071.00 ns (0.4%)
   gen split merge   : 865.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 922.00 ns  (0.3%)
   LB compute        : 282.96 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.902152038992579e-18,-4.4213168282764e-17,2.4640933824621182e-18)
    sum a = (2.5479618415147344e-17,1.8778923728535178e-17,-3.850630751756068e-17)
    sum e = 2.5920008964440644
    sum de = 9.961107459710572e-19
Info: CFL hydro = 0.009397988050364141 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009397988050364141 cfl multiplier : 0.8356729331558063        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0242e+04 |  512 |      1 | 2.529e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1205.7804395973044 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.817922707138891, dt = 0.009397988050364141 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.4%)
   patch tree reduce : 1372.00 ns (0.5%)
   gen split merge   : 638.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 774.00 ns  (0.3%)
   LB compute        : 270.60 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1895.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.710410884788517e-18,-4.363062645548754e-17,1.7139610043737097e-18)
    sum a = (-9.683660123771531e-17,-1.433228535852038e-16,1.0366902648828447e-16)
    sum e = 2.592000939191311
    sum de = 7.589415207398531e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011113401515493403
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.141462563514442e-18,-4.4305379677533894e-17,2.4165240121443165e-18)
    sum a = (8.393286066166184e-17,1.1832331989203304e-17,-1.1724605661345144e-16)
    sum e = 2.592000791444207
    sum de = 2.303929616531697e-19
Info: CFL hydro = 0.005009936149541544 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005009936149541544 cfl multiplier : 0.4452243110519354        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4938e+04 |  512 |      1 | 3.427e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 987.1286918445251 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.827320695189255, dt = 0.005009936149541544 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1295.00 ns (0.4%)
   gen split merge   : 786.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 870.00 ns  (0.3%)
   LB compute        : 284.37 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1956.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.883801595958413e-18,-4.369502806453318e-17,7.40618504024848e-19)
    sum a = (1.6463393148757886e-17,5.3336241673251905e-17,6.616972594852832e-17)
    sum e = 2.592000832500628
    sum de = -1.3823577699190182e-18
Info: CFL hydro = 0.007092654164253043 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007092654164253043 cfl multiplier : 0.6301495407012903        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9584e+04 |  512 |      1 | 2.614e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 689.8587572442904 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.832330631338796, dt = 0.007092654164253043 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.4%)
   patch tree reduce : 1179.00 ns (0.4%)
   gen split merge   : 1299.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 880.00 ns  (0.3%)
   LB compute        : 276.24 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1893.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.7352387932735865e-18,-4.319884294029519e-17,1.7395752806986798e-18)
    sum a = (3.6369345035591747e-17,-1.6526623819457241e-16,4.36877096998689e-17)
    sum e = 2.592000885555671
    sum de = -6.098637220230962e-19
Info: CFL hydro = 0.008484642051450952 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008484642051450952 cfl multiplier : 0.7534330271341935        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9841e+04 |  512 |      1 | 2.580e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 989.4829848243414 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.839423285503049, dt = 0.008484642051450952 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.5%)
   patch tree reduce : 1007.00 ns (0.3%)
   gen split merge   : 706.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1319.00 ns (0.4%)
   LB compute        : 277.74 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.4566835382395376e-18,-4.5243594027494226e-17,2.0176731379412114e-18)
    sum a = (-9.231677922105774e-17,4.019831342794156e-17,3.901273835232866e-17)
    sum e = 2.5920009421387387
    sum de = 4.1335207826009857e-19
Info: CFL hydro = 0.009418042511388705 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009418042511388705 cfl multiplier : 0.8356220180894622        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9201e+04 |  512 |      1 | 2.666e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1145.51382190988 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 5.8479079275545, dt = 0.009418042511388705 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.4%)
   patch tree reduce : 1167.00 ns (0.4%)
   gen split merge   : 672.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1039.00 ns (0.3%)
   LB compute        : 289.75 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1971.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.829700228816235e-18,-4.3962880211245724e-17,2.487512149387805e-18)
    sum a = (-7.866363810338228e-17,-2.047971167651319e-17,-4.209852681302112e-17)
    sum e = 2.5920009986779786
    sum de = -3.8285889215894375e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011087724650913428
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.864096542738338e-18,-4.4199995226368305e-17,2.029382521404055e-18)
    sum a = (6.571305999347743e-17,4.033882602949568e-17,-4.860528483602994e-17)
    sum e = 2.5920007953011956
    sum de = -8.131516293641283e-19
Info: CFL hydro = 0.005024407380824728 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005024407380824728 cfl multiplier : 0.4452073393631541        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4576e+04 |  512 |      1 | 3.513e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 965.2425935428082 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.857325970065888, dt = 0.005024407380824728 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.5%)
   patch tree reduce : 1169.00 ns (0.4%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1037.00 ns (0.3%)
   LB compute        : 282.75 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.41 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.7158451269132523e-18,-4.3857495760080135e-17,1.767385066422933e-18)
    sum a = (2.398081733190338e-17,3.284482061327587e-17,1.501728429109672e-18)
    sum e = 2.592000852214615
    sum de = -6.606856988583543e-19
Info: CFL hydro = 0.007116544960385081 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007116544960385081 cfl multiplier : 0.6301382262421028        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9571e+04 |  512 |      1 | 2.616e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 691.4191253249994 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.862350377446713, dt = 0.007116544960385081 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.4%)
   patch tree reduce : 1185.00 ns (0.4%)
   gen split merge   : 626.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1377.00 ns (0.4%)
   LB compute        : 296.38 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.862944256665223e-18,-4.358305708516974e-17,1.903506649178488e-18)
    sum a = (-1.563905255297371e-16,-4.2013267864682293e-17,-7.30767985186731e-17)
    sum e = 2.5920009213746815
    sum de = -1.8770250111155296e-18
Info: CFL hydro = 0.008518705339041237 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008518705339041237 cfl multiplier : 0.753425484161402         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9747e+04 |  512 |      1 | 2.593e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 988.0836256002378 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.869466922407098, dt = 0.008518705339041237 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.70 us    (1.6%)
   patch tree reduce : 1058.00 ns (0.4%)
   gen split merge   : 699.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1229.00 ns (0.4%)
   LB compute        : 275.66 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.504453450862589e-18,-4.4221950320361135e-17,1.0340849270623619e-18)
    sum a = (-4.4964032497318837e-17,5.484675213995871e-17,1.0061580475034803e-16)
    sum e = 2.592000990342506
    sum de = 4.3029273720518457e-19
Info: CFL hydro = 0.009462867963224552 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009462867963224552 cfl multiplier : 0.8356169894409348        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9895e+04 |  512 |      1 | 2.574e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1191.6399079644843 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.877985627746139, dt = 0.009462867963224552 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.5%)
   patch tree reduce : 1366.00 ns (0.5%)
   gen split merge   : 656.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 911.00 ns  (0.3%)
   LB compute        : 274.49 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.6456978888831376e-18,-4.3394975113297817e-17,2.6924263599875653e-18)
    sum a = (7.728193085476676e-19,-1.681467465264319e-17,1.815891187417762e-16)
    sum e = 2.5920010527262534
    sum de = 7.928228386300251e-19
Info: CFL hydro = 0.010073419172996072 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010073419172996072 cfl multiplier : 0.8904113262939566        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9588e+04 |  512 |      1 | 2.614e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1303.308053530245 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.887448495709364, dt = 0.010073419172996072 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.4%)
   patch tree reduce : 1233.00 ns (0.4%)
   gen split merge   : 628.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1004.00 ns (0.3%)
   LB compute        : 272.75 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1995.00 ns (64.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.325153516587798e-18,-4.380407169803091e-17,4.941359821319935e-18)
    sum a = (1.0664906457957812e-16,6.049067496904925e-17,-4.7932361205149655e-17)
    sum e = 2.592001103387943
    sum de = -9.300421760852218e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011505056754851996
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.864096542738338e-18,-4.336094471760893e-17,3.75432107277418e-18)
    sum a = (7.063100104787168e-17,2.8032264010047217e-17,-6.99108739649068e-17)
    sum e = 2.5920008012475884
    sum de = 3.3881317890172014e-20
Info: CFL hydro = 0.005236507061992738 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005236507061992738 cfl multiplier : 0.46347044209798555       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4841e+04 |  512 |      1 | 3.450e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1051.168702813854 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.89752191488236, dt = 0.005236507061992738 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.5%)
   patch tree reduce : 1682.00 ns (0.6%)
   gen split merge   : 700.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1036.00 ns (0.4%)
   LB compute        : 273.19 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.669428042668565e-18,-4.351280078439268e-17,3.244231055674063e-18)
    sum a = (1.9297063946766003e-17,5.1849149973470786e-17,-1.2728099824110828e-16)
    sum e = 2.592000881742331
    sum de = 1.0164395367051604e-19
Info: CFL hydro = 0.007252316093553215 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007252316093553215 cfl multiplier : 0.6423136280653238        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9941e+04 |  512 |      1 | 2.568e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 734.1964450977614 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.902758421944353, dt = 0.007252316093553215 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.5%)
   patch tree reduce : 1643.00 ns (0.6%)
   gen split merge   : 659.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1007.00 ns (0.3%)
   LB compute        : 273.83 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.6767464073328425e-18,-4.2994683436051434e-17,2.1728224688238872e-18)
    sum a = (9.057208108509407e-17,1.5807667674838655e-16,2.5186883828576256e-17)
    sum e = 2.5920009608879813
    sum de = -6.844026213814747e-19
Info: CFL hydro = 0.008591293792119247 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008591293792119247 cfl multiplier : 0.7615424187102159        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0404e+04 |  512 |      1 | 2.509e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1040.4535413615008 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.910010738037906, dt = 0.008591293792119247 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.4%)
   patch tree reduce : 1274.00 ns (0.4%)
   gen split merge   : 632.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 831.00 ns  (0.3%)
   LB compute        : 273.04 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1990.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.6404659708711974e-18,-4.136266524602805e-17,2.9185638281137294e-18)
    sum a = (6.106443475872858e-17,-1.2718732317340553e-16,-1.932048271369169e-18)
    sum e = 2.592001028837991
    sum de = -1.7753810574450135e-18
Info: CFL hydro = 0.00947978483702665 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00947978483702665 cfl multiplier : 0.8410282791401439         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9592e+04 |  512 |      1 | 2.613e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1183.4889978435797 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.918602031830026, dt = 0.00947978483702665 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1124.00 ns (0.4%)
   gen split merge   : 647.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 854.00 ns  (0.3%)
   LB compute        : 269.68 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1992.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.1955093992831465e-18,-4.385347065951478e-17,2.7356047115068006e-18)
    sum a = (-1.1381520725883831e-16,-2.0020703844769728e-16,9.824172725325652e-18)
    sum e = 2.592001078595353
    sum de = 1.9651164376299768e-19
Info: CFL hydro = 0.010069186196438073 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010069186196438073 cfl multiplier : 0.894018852760096         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9961e+04 |  512 |      1 | 2.565e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1330.511990252045 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.928081816667052, dt = 0.010069186196438073 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.72 us    (1.3%)
   patch tree reduce : 984.00 ns  (0.3%)
   gen split merge   : 749.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 852.00 ns  (0.3%)
   LB compute        : 268.29 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1882.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.4276106218876786e-18,-4.619644510678311e-17,2.8867289418241236e-18)
    sum a = (8.177833410449865e-17,-3.7657377216504526e-17,-3.247012034246488e-17)
    sum e = 2.592001108990362
    sum de = 2.778268066994105e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011215713336657235
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.0898135612578148e-18,-4.541338008770546e-17,2.749509604368927e-18)
    sum a = (-8.782037597132586e-18,2.1147146533895267e-17,5.025667382252408e-17)
    sum e = 2.5920007997972148
    sum de = 1.07742590890747e-18
Info: CFL hydro = 0.005230871461167978 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005230871461167978 cfl multiplier : 0.46467295092003197       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4792e+04 |  512 |      1 | 3.461e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1047.2235184520623 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.93815100286349, dt = 0.005230871461167978 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1032.00 ns (0.3%)
   gen split merge   : 682.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1061.00 ns (0.4%)
   LB compute        : 281.68 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1806.00 ns (63.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.751393726908469e-18,-4.481034683936902e-17,3.393159776592103e-18)
    sum a = (3.7177292494527946e-18,1.2388527703688367e-17,-1.3573517310128124e-16)
    sum e = 2.5920008828341685
    sum de = 2.439454888092385e-19
Info: CFL hydro = 0.007237763678802955 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007237763678802955 cfl multiplier : 0.6431153006133546        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8753e+04 |  512 |      1 | 2.730e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 689.7239051488284 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.9433818743246585, dt = 0.007237763678802955 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 1201.00 ns (0.4%)
   gen split merge   : 656.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 957.00 ns  (0.3%)
   LB compute        : 273.89 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1935.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.739684343445626e-18,-4.46303150686278e-17,1.9457702051146884e-18)
    sum a = (8.598200276765944e-17,-5.995204332975846e-17,7.862850995299376e-17)
    sum e = 2.592000953061241
    sum de = -5.421010862427522e-20
Info: CFL hydro = 0.008574539212418221 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008574539212418221 cfl multiplier : 0.7620768670755697        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9482e+04 |  512 |      1 | 2.628e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 991.4284513310507 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.950619638003461, dt = 0.008574539212418221 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.5%)
   patch tree reduce : 1702.00 ns (0.6%)
   gen split merge   : 660.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 983.00 ns  (0.3%)
   LB compute        : 288.85 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1869.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.441406452002859e-18,-4.5567065745655276e-17,3.4369670500746745e-18)
    sum a = (4.53036046177413e-17,-1.5980966550088737e-16,-2.3137741722578652e-17)
    sum e = 2.592001005190549
    sum de = -3.9979955110402976e-19
Info: CFL hydro = 0.009465782645404527 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009465782645404527 cfl multiplier : 0.8413845780503797        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9545e+04 |  512 |      1 | 2.620e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1178.3928912980684 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.959194177215879, dt = 0.009465782645404527 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.4%)
   patch tree reduce : 1537.00 ns (0.5%)
   gen split merge   : 795.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 859.00 ns  (0.3%)
   LB compute        : 286.89 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (70.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.199900418081713e-18,-4.7358601415470323e-17,2.7237123689273502e-18)
    sum a = (-1.1271964806859603e-16,2.7470213603830728e-17,2.5210302595501943e-17)
    sum e = 2.5920010347388223
    sum de = -2.7172816947917955e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011344669003739642
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.914172809315163e-18,-4.645844256176423e-17,2.9286265795271106e-18)
    sum a = (-9.319644665370386e-17,-5.938999292354196e-17,7.437800375598158e-17)
    sum e = 2.592000797976108
    sum de = -1.429791614965259e-18
Info: CFL hydro = 0.005031283716424291 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005031283716424291 cfl multiplier : 0.4471281926834599        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4947e+04 |  512 |      1 | 3.425e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 994.8326208129865 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.9686599598612835, dt = 0.005031283716424291 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.5%)
   patch tree reduce : 1234.00 ns (0.4%)
   gen split merge   : 645.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 894.00 ns  (0.3%)
   LB compute        : 275.90 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.54 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1921.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.3971848771574554e-18,-4.734689203200748e-17,3.589474908711337e-18)
    sum a = (4.5432407835832574e-18,5.334795105671475e-17,-4.017489466101587e-17)
    sum e = 2.592000864699264
    sum de = -1.2671612890924333e-18
Info: CFL hydro = 0.007105809512956864 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007105809512956864 cfl multiplier : 0.6314187951223066        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9469e+04 |  512 |      1 | 2.630e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 688.741223304491 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 5.973691243577708, dt = 0.007105809512956864 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.01 us    (1.7%)
   patch tree reduce : 1400.00 ns (0.5%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 894.00 ns  (0.3%)
   LB compute        : 282.65 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.212762087617671e-18,-4.6574072723459813e-17,2.973451563095808e-18)
    sum a = (8.635084834673901e-17,-7.285578390581193e-17,-4.258702765436162e-17)
    sum e = 2.592000921293927
    sum de = -1.7753810574450135e-18
Info: CFL hydro = 0.008490806726032763 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008490806726032763 cfl multiplier : 0.7542791967482044        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9594e+04 |  512 |      1 | 2.613e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 978.9521799963403 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.980797053090665, dt = 0.008490806726032763 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.6%)
   patch tree reduce : 1445.00 ns (0.5%)
   gen split merge   : 764.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1002.00 ns (0.3%)
   LB compute        : 273.14 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.36 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1955.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.0959796398489773e-18,-4.752106911101728e-17,2.6430273985036943e-18)
    sum a = (8.057226760782577e-17,-4.5362151535055517e-17,4.0748654450695194e-18)
    sum e = 2.5920009603363066
    sum de = 2.303929616531697e-19
Info: CFL hydro = 0.009411369427640953 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009411369427640953 cfl multiplier : 0.8361861311654696        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9253e+04 |  512 |      1 | 2.659e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1149.4154182683787 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 5.989287859816698, dt = 0.009411369427640953 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 1265.00 ns (0.4%)
   gen split merge   : 636.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1041.00 ns (0.4%)
   LB compute        : 277.70 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3334060418312977e-18,-4.806701911497235e-17,2.8069587669835026e-18)
    sum a = (8.221158129262385e-17,5.71886288325274e-17,5.978811196127864e-17)
    sum e = 2.592000979145239
    sum de = 1.2739375526704677e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011030305921531718
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.304132583174189e-18,-4.737616549066459e-17,3.1187211016817097e-18)
    sum a = (-1.0020890367501423e-16,1.3137928245310349e-17,-3.11820881615521e-17)
    sum e = 2.5920007967688603
    sum de = 9.486769009248164e-19
Info: CFL hydro = 0.005003339032792681 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005003339032792681 cfl multiplier : 0.4453953770551566        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4867e+04 |  512 |      1 | 3.444e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 983.8048315892405 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 5.998699229244338, dt = 0.0013007707556615955 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 1343.00 ns (0.4%)
   gen split merge   : 653.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 922.00 ns  (0.3%)
   LB compute        : 300.39 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1939.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.286257121120183e-18,-4.7437639753844515e-17,2.738532057372511e-18)
    sum a = (2.7470213603830728e-17,5.058453655948369e-18,1.4882626381274022e-17)
    sum e = 2.59200080343981
    sum de = 2.5343225781848666e-18
Info: CFL hydro = 0.007078206439570032 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007078206439570032 cfl multiplier : 0.6302635847034378        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0319e+04 |  512 |      1 | 2.520e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 185.84015320591843 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 809                                                     [SPH][rank=0]
Info: time since start : 1760.487037519 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14980310093564989 max=0.1501652885231681 delta=0.00036218758751821456
Number of particle pairs: 130816
Distance min=0.146198 max=1.990435 mean=0.806440
---------------- t = 6, dt = 0.007078206439570032 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 8.95 us    (1.7%)
   patch tree reduce : 1044.00 ns (0.2%)
   gen split merge   : 523.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 874.00 ns  (0.2%)
   LB compute        : 511.17 us  (95.7%)
   LB move op cnt    : 0
   LB apply          : 4.41 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.99 us    (82.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.2086824556788455e-18,-4.7777211874266975e-17,2.8614805837323674e-18)
    sum a = (-8.69421722116126e-17,-1.7845100397373413e-17,-5.631042507281414e-17)
    sum e = 2.592000894967468
    sum de = 4.607859233063394e-19
Info: CFL hydro = 0.00845031097050325 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00845031097050325 cfl multiplier : 0.7535090564689586         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4082e+04 |  512 |      1 | 3.636e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 700.826897671006 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 6.00707820643957, dt = 0.00845031097050325 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.4%)
   patch tree reduce : 913.00 ns  (0.3%)
   gen split merge   : 633.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 862.00 ns  (0.3%)
   LB compute        : 290.77 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1834.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.230326162811936e-18,-4.764548131030999e-17,2.0176731379412114e-18)
    sum a = (-8.152072766831608e-17,-9.664925110230982e-17,-6.34414396016858e-17)
    sum e = 2.5920009233871366
    sum de = 1.395910297075087e-18
Info: CFL hydro = 0.00935859277107199 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00935859277107199 cfl multiplier : 0.8356727043126391         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7082e+04 |  512 |      1 | 2.997e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1014.9273739364197 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.015528517410074, dt = 0.00935859277107199 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.89 us    (1.3%)
   patch tree reduce : 1157.00 ns (0.3%)
   gen split merge   : 1015.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1030.00 ns (0.3%)
   LB compute        : 353.75 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.58 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.73 us    (72.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.033882602949568e-18,-4.922624807779385e-17,1.3963439779440811e-18)
    sum a = (5.992862456283277e-17,4.0432501097198423e-17,1.0622752677491575e-16)
    sum e = 2.5920009378937587
    sum de = -1.0706496453294356e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011312076000095433
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.3971848771574554e-18,-4.8219241099989315e-17,2.2621065177280684e-18)
    sum a = (1.8079288066630285e-17,-1.2101647808848704e-16,-1.0538445116559103e-19)
    sum e = 2.5920007975570414
    sum de = 2.0735366548785272e-18
Info: CFL hydro = 0.004980733864244106 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004980733864244106 cfl multiplier : 0.4452242347708797        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.3472e+04 |  512 |      1 | 3.801e-02 | 0.1% |   2.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 886.4796518133693 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.024887110181146, dt = 0.004980733864244106 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.4%)
   patch tree reduce : 1067.00 ns (0.3%)
   gen split merge   : 798.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 295.14 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (61.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.531842786980155e-18,-4.9905392318638774e-17,1.7190838596387037e-18)
    sum a = (-9.018567143082024e-17,-8.803114487365704e-17,-2.8278161062766926e-17)
    sum e = 2.592000837069885
    sum de = -1.2197274440461925e-18
Info: CFL hydro = 0.007045660941683976 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007045660941683976 cfl multiplier : 0.6301494898472532        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9002e+04 |  512 |      1 | 2.695e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 665.4529572509018 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.0298678440453894, dt = 0.007045660941683976 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.3%)
   patch tree reduce : 921.00 ns  (0.3%)
   gen split merge   : 755.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 831.00 ns  (0.3%)
   LB compute        : 279.04 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.33759473651707e-18,-5.0288874627046895e-17,1.453427222325443e-18)
    sum a = (-1.0753897772275422e-16,-4.127557670652315e-17,-4.478839174537619e-17)
    sum e = 2.5920008711399727
    sum de = -1.8973538018496328e-19
Info: CFL hydro = 0.008419173966770062 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008419173966770062 cfl multiplier : 0.7534329932315021        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9570e+04 |  512 |      1 | 2.616e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 969.4774130912778 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.036913504987074, dt = 0.008419173966770062 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.3%)
   patch tree reduce : 1014.00 ns (0.3%)
   gen split merge   : 709.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 884.00 ns  (0.3%)
   LB compute        : 296.20 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.72 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1967.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.339478859056612e-18,-5.054062637149803e-17,1.0011522860731148e-18)
    sum a = (-1.2842851782046695e-16,-1.878185107440089e-17,7.115792330369964e-17)
    sum e = 2.592000897053546
    sum de = 2.981555974335137e-19
Info: CFL hydro = 0.009333662485311202 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009333662485311202 cfl multiplier : 0.835621995487668         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9342e+04 |  512 |      1 | 2.647e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1145.023415002919 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.0453326789538435, dt = 0.009333662485311202 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.3%)
   patch tree reduce : 1020.00 ns (0.3%)
   gen split merge   : 841.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 982.00 ns  (0.3%)
   LB compute        : 307.90 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1987.00 ns (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.594944317213358e-18,-5.0505498221109503e-17,2.1135437150432423e-18)
    sum a = (3.922643460052555e-17,-2.3986672023634803e-17,-2.937884310827421e-17)
    sum e = 2.5920009157461377
    sum de = -9.622294280808852e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011269764102725866
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.69405362704084e-18,-5.047037007072097e-17,1.620285936670962e-18)
    sum a = (-3.969480993903929e-17,-5.936657415661627e-17,2.2452742790002312e-17)
    sum e = 2.5920007995262537
    sum de = 2.439454888092385e-19
Info: CFL hydro = 0.004973129050473483 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004973129050473483 cfl multiplier : 0.4452073318292227        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4322e+04 |  512 |      1 | 3.575e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 939.9185775885865 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.054666341439154, dt = 0.004973129050473483 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.3%)
   patch tree reduce : 1234.00 ns (0.4%)
   gen split merge   : 924.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 964.00 ns  (0.3%)
   LB compute        : 298.39 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1979.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.376491131984685e-18,-5.119342449955155e-17,1.975958459354832e-18)
    sum a = (-5.5104358576141265e-17,6.779733024986356e-17,-1.1287845658181083e-16)
    sum e = 2.5920008320655175
    sum de = 4.87890977618477e-19
Info: CFL hydro = 0.0070392061677020815 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070392061677020815 cfl multiplier : 0.6301382212194818       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9949e+04 |  512 |      1 | 2.567e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 697.5721233720277 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.0596394704896275, dt = 0.0070392061677020815 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.5%)
   patch tree reduce : 1107.00 ns (0.4%)
   gen split merge   : 1018.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 281.83 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1828.00 ns (63.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.6684938820893436e-18,-5.027423789771834e-17,9.0015885370609e-19)
    sum a = (-1.1409623246194657e-16,1.3108654786653239e-17,1.01871636126738e-16)
    sum e = 2.592000865451657
    sum de = -2.7172816947917955e-18
Info: CFL hydro = 0.008418591173638895 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008418591173638895 cfl multiplier : 0.753425480812988         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9825e+04 |  512 |      1 | 2.583e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 981.2265896132936 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.06667867665733, dt = 0.008418591173638895 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.6%)
   patch tree reduce : 1056.00 ns (0.4%)
   gen split merge   : 720.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1087.00 ns (0.4%)
   LB compute        : 274.47 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.78 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1820.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.039772461058276e-18,-5.0479152108318106e-17,2.507271733981353e-18)
    sum a = (-4.6369158512860054e-17,-2.2580448253393948e-17,1.1469341101855157e-17)
    sum e = 2.592000896590855
    sum de = 4.811147140404426e-19
Info: CFL hydro = 0.009342392043750208 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009342392043750208 cfl multiplier : 0.8356169872086587        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9305e+04 |  512 |      1 | 2.652e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1142.7321420805488 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.0750972678309685, dt = 0.009342392043750208 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.5%)
   patch tree reduce : 874.00 ns  (0.3%)
   gen split merge   : 692.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 931.00 ns  (0.3%)
   LB compute        : 275.97 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1904.00 ns (64.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.166197210633663e-18,-5.0862634416726227e-17,2.1925820534174355e-18)
    sum a = (2.7399957303053668e-17,1.1942692928340604e-16,-2.883435677725199e-18)
    sum e = 2.5920009258191397
    sum de = -1.1248597539537109e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01090131379318125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.904565673885755e-18,-5.0183490175881306e-17,2.1413535007674954e-18)
    sum a = (1.874906480070493e-16,-7.003089514540096e-17,7.649154747102483e-18)
    sum e = 2.5920008027186716
    sum de = -1.917682592583736e-18
Info: CFL hydro = 0.004983189005465969 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004983189005465969 cfl multiplier : 0.4452056624028862        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4613e+04 |  512 |      1 | 3.504e-02 | 0.0% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 959.8935048310958 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.084439659874719, dt = 0.004983189005465969 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1366.00 ns (0.5%)
   gen split merge   : 756.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 954.00 ns  (0.3%)
   LB compute        : 282.40 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.167185902586358e-18,-5.1331009755239964e-17,2.201364091014568e-18)
    sum a = (-9.152054114558439e-17,-7.400330348517059e-18,1.7541973732979054e-16)
    sum e = 2.5920008370722023
    sum de = -1.8634724839594607e-18
Info: CFL hydro = 0.007057513335401387 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007057513335401387 cfl multiplier : 0.6301371082685908        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9689e+04 |  512 |      1 | 2.600e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 689.8578847628431 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.089422848880185, dt = 0.007057513335401387 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.4%)
   patch tree reduce : 948.00 ns  (0.3%)
   gen split merge   : 894.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 940.00 ns  (0.3%)
   LB compute        : 290.89 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1859.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.51815601961192e-18,-5.131930037177712e-17,3.826041046484097e-18)
    sum a = (-4.318420621096663e-17,1.0674859433901229e-16,-1.1975918303916421e-16)
    sum e = 2.5920008778831005
    sum de = 1.2739375526704677e-18
Info: CFL hydro = 0.008447229426479656 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008447229426479656 cfl multiplier : 0.7534247388457272        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9646e+04 |  512 |      1 | 2.606e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 974.8789291617708 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.096480362215586, dt = 0.008447229426479656 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.66 us    (1.6%)
   patch tree reduce : 1002.00 ns (0.3%)
   gen split merge   : 716.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 995.00 ns  (0.3%)
   LB compute        : 278.60 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1799.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.706237991483844e-18,-4.9984430657012966e-17,1.874965026987807e-18)
    sum a = (-1.452900300069615e-16,1.6393136847980826e-17,-1.4337481397432016e-16)
    sum e = 2.592000919725382
    sum de = 1.8973538018496328e-19
Info: CFL hydro = 0.009382853158537307 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009382853158537307 cfl multiplier : 0.8356164925638181        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9437e+04 |  512 |      1 | 2.634e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1154.4770145882628 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.104927591642066, dt = 0.009382853158537307 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.89 us    (1.6%)
   patch tree reduce : 1175.00 ns (0.4%)
   gen split merge   : 823.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1308.00 ns (0.4%)
   LB compute        : 281.15 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1856.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.575348326740229e-18,-5.02098362886727e-17,3.585998685495806e-19)
    sum a = (3.9484041036708105e-17,-8.111089924711656e-17,-1.9203388879063254e-18)
    sum e = 2.5920009610251036
    sum de = 4.336808689942018e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011139576654908556
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.651770706108453e-18,-5.07748140407549e-17,1.0684812409844647e-18)
    sum a = (-5.62987156893513e-17,-1.752309235214522e-16,1.1638541692893244e-16)
    sum e = 2.592000806138592
    sum de = 2.913793338554793e-19
Info: CFL hydro = 0.005009540918938956 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005009540918938956 cfl multiplier : 0.4452054975212727        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4736e+04 |  512 |      1 | 3.475e-02 | 0.0% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 972.1660591440581 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.114310444800603, dt = 0.005009540918938956 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 953.00 ns  (0.3%)
   gen split merge   : 640.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 954.00 ns  (0.3%)
   LB compute        : 277.32 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1962.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.364579424409048e-18,-5.195746177050209e-17,2.211609801544556e-18)
    sum a = (-8.397969819551321e-17,-1.8500825871292646e-17,2.3497805264061087e-17)
    sum e = 2.5920008494929503
    sum de = 9.859463506040056e-19
Info: CFL hydro = 0.00709745637061599 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00709745637061599 cfl multiplier : 0.6301369983475151         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9786e+04 |  512 |      1 | 2.588e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 696.9197046862615 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.119319985719542, dt = 0.00709745637061599 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 1061.00 ns (0.4%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1526.00 ns (0.5%)
   LB compute        : 274.60 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1923.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0037868973522546e-17,-5.167936391325956e-17,2.054996797729025e-18)
    sum a = (-8.013902041970056e-17,5.546734946348941e-17,5.60293998697059e-17)
    sum e = 2.592000901992477
    sum de = -1.5585406229479126e-19
Info: CFL hydro = 0.008489748375534616 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008489748375534616 cfl multiplier : 0.7534246655650101        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9672e+04 |  512 |      1 | 2.603e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 981.7121299352679 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.126417442090158, dt = 0.008489748375534616 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.4%)
   patch tree reduce : 1334.00 ns (0.4%)
   gen split merge   : 702.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 908.00 ns  (0.3%)
   LB compute        : 293.94 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1935.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0705303830904623e-17,-5.1047057206266013e-17,2.6302202603412094e-18)
    sum a = (-1.704886232190006e-17,9.390925537200445e-17,-1.8254928818572934e-17)
    sum e = 2.5920009546818945
    sum de = -4.743384504624082e-19
Info: CFL hydro = 0.009422938583176433 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009422938583176433 cfl multiplier : 0.8356164437100068        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9318e+04 |  512 |      1 | 2.650e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1153.1627342902714 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.134907190465693, dt = 0.009422938583176433 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.86 us    (1.6%)
   patch tree reduce : 965.00 ns  (0.3%)
   gen split merge   : 764.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 958.00 ns  (0.3%)
   LB compute        : 294.58 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.38 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0594064688007609e-17,-5.0007849423938653e-17,2.1311077902375074e-18)
    sum a = (2.964815892791961e-17,-2.391056103112632e-17,-1.6067615987713778e-16)
    sum e = 2.592001003634493
    sum de = 9.486769009248164e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010381219710753323
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0433060665393511e-17,-5.053477167976661e-17,1.4343994741983224e-18)
    sum a = (-3.700165174258529e-17,-8.243405957841787e-18,-1.1814767914009038e-17)
    sum e = 2.5920008087085997
    sum de = -8.961608581950498e-19
Info: CFL hydro = 0.005022789141237073 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005022789141237073 cfl multiplier : 0.445205481236669         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4633e+04 |  512 |      1 | 3.499e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 969.4818733228491 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.144330129048869, dt = 0.005022789141237073 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.80 us    (1.6%)
   patch tree reduce : 988.00 ns  (0.3%)
   gen split merge   : 1130.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 911.00 ns  (0.3%)
   LB compute        : 287.68 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1928.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0974619650550021e-17,-5.0549408409095163e-17,2.0857339293189892e-18)
    sum a = (9.50801937182888e-17,6.107614414219142e-17,1.735330629193399e-17)
    sum e = 2.592000863294207
    sum de = 5.412540532954979e-19
Info: CFL hydro = 0.0071101472029237315 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0071101472029237315 cfl multiplier : 0.6301369874911127       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9064e+04 |  512 |      1 | 2.686e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 673.2601320711874 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.1493529181901065, dt = 0.0071101472029237315 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1623.00 ns (0.5%)
   gen split merge   : 758.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 985.00 ns  (0.3%)
   LB compute        : 283.68 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1868.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.923702484759822e-18,-4.995808454422157e-17,2.2386877508023818e-18)
    sum a = (-1.038388125484957e-16,4.7493259325293025e-17,2.505808061048498e-17)
    sum e = 2.592000925435555
    sum de = 4.657622418714584e-19
Info: CFL hydro = 0.008502038439588026 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008502038439588026 cfl multiplier : 0.7534246583274085        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9702e+04 |  512 |      1 | 2.599e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 984.9890382227338 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.15646306539303, dt = 0.008502038439588026 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.4%)
   patch tree reduce : 1498.00 ns (0.5%)
   gen split merge   : 863.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 969.00 ns  (0.3%)
   LB compute        : 287.33 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1807.00 ns (64.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1460559064258024e-17,-4.968584137871046e-17,2.5328860103063234e-18)
    sum a = (1.2692971673722298e-17,-1.0273813050298841e-16,1.0173112352518387e-16)
    sum e = 2.5920009837894136
    sum de = -8.54656243779589e-19
Info: CFL hydro = 0.009430093126390895 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009430093126390895 cfl multiplier : 0.835616438884939         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9794e+04 |  512 |      1 | 2.587e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1183.2596982002797 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.1649651038326185, dt = 0.009430093126390895 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1184.00 ns (0.4%)
   gen split merge   : 759.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1024.00 ns (0.3%)
   LB compute        : 295.87 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.53 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0924854770832936e-17,-5.1228552649940085e-17,3.794572078427705e-18)
    sum a = (-5.929631785583922e-17,8.943627088919825e-17,-1.3244483634822224e-16)
    sum e = 2.5920010325936373
    sum de = 2.0498197323554068e-19
Info: CFL hydro = 0.010051124227648575 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010051124227648575 cfl multiplier : 0.890410959256626         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9239e+04 |  512 |      1 | 2.661e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1275.6706168554008 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.17439519695901, dt = 0.010051124227648575 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.3%)
   patch tree reduce : 1681.00 ns (0.6%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1008.00 ns (0.3%)
   LB compute        : 286.76 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1914.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1767930380157664e-17,-4.946482676584929e-17,1.4241537636683344e-18)
    sum a = (-3.6486438870220186e-17,-7.508056676375219e-17,-7.18487769280074e-17)
    sum e = 2.592001069946537
    sum de = -5.04831636563563e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010756770377032546
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1659618583126363e-17,-5.0203981596941284e-17,1.6810283633844624e-18)
    sum a = (-4.8617360137725995e-17,-1.1269110644640535e-16,9.444788701129526e-17)
    sum e = 2.5920008117952706
    sum de = -1.446732273910345e-18
Info: CFL hydro = 0.0052349862934365325 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0052349862934365325 cfl multiplier : 0.4634703197522086       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4535e+04 |  512 |      1 | 3.522e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1027.2464448426347 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.184446321186658, dt = 0.0052349862934365325 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 1489.00 ns (0.5%)
   gen split merge   : 840.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 919.00 ns  (0.3%)
   LB compute        : 285.26 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.199040866595169e-17,-5.10309568040046e-17,3.0137025687493322e-18)
    sum a = (-1.4519635493925875e-18,4.6345739745934367e-17,2.6217309573306478e-17)
    sum e = 2.592000881004135
    sum de = 5.454892180317694e-19
Info: CFL hydro = 0.007257439411442145 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007257439411442145 cfl multiplier : 0.6423135465014723        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9736e+04 |  512 |      1 | 2.594e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 726.4509139722177 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.189681307480095, dt = 0.007257439411442145 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 895.00 ns  (0.3%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 934.00 ns  (0.3%)
   LB compute        : 288.76 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1996.00 ns (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1867460139591834e-17,-5.027862891651691e-17,3.007116040551483e-18)
    sum a = (-4.4097538121068426e-17,-9.34642988004164e-17,-1.5514933088267568e-17)
    sum e = 2.5920009461012516
    sum de = 8.809142651444724e-19
Info: CFL hydro = 0.008609483623443175 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008609483623443175 cfl multiplier : 0.7615423643343148        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9074e+04 |  512 |      1 | 2.684e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 973.3233299727272 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.196938746891537, dt = 0.008609483623443175 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 983.00 ns  (0.3%)
   gen split merge   : 802.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1438.00 ns (0.5%)
   LB compute        : 283.75 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1942.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2312416711179885e-17,-5.1670581875662424e-17,2.804031421117792e-18)
    sum a = (-8.397969819551321e-17,-4.5947620708197687e-17,-2.5760643618255585e-17)
    sum e = 2.592001000225757
    sum de = 4.946672411965114e-19
Info: CFL hydro = 0.00951455569128621 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00951455569128621 cfl multiplier : 0.8410282428895431         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9511e+04 |  512 |      1 | 2.624e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1181.1340528991777 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.205548230514981, dt = 0.00951455569128621 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.4%)
   patch tree reduce : 922.00 ns  (0.3%)
   gen split merge   : 642.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1287.00 ns (0.4%)
   LB compute        : 273.73 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1846.00 ns (62.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3137928245310349e-17,-5.196112095283423e-17,2.4554943039815925e-18)
    sum a = (1.5730385743983889e-16,-7.205954583033857e-17,-1.4800660697034118e-17)
    sum e = 2.5920010383996943
    sum de = 1.4230153513872246e-19
Info: CFL hydro = 0.010104867474088595 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010104867474088595 cfl multiplier : 0.8940188285930288        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9506e+04 |  512 |      1 | 2.625e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1304.910370317147 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.215062786206267, dt = 0.010104867474088595 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.92 us    (1.3%)
   patch tree reduce : 1022.00 ns (0.3%)
   gen split merge   : 725.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 916.00 ns  (0.3%)
   LB compute        : 277.74 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.67 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1917.00 ns (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0544299808290525e-17,-5.260001418802562e-17,2.35338024702535e-18)
    sum a = (-6.524468465496369e-17,2.498782430970792e-17,7.571287347074573e-17)
    sum e = 2.592001060036565
    sum de = 1.6737371037744975e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011714202656258986
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.178549445535193e-17,-5.2321550412549876e-17,2.7989543056319497e-18)
    sum a = (-1.301966347233563e-16,2.8781664551669195e-17,-7.913201344189602e-17)
    sum e = 2.5920008104678787
    sum de = 8.944667923005412e-19
Info: CFL hydro = 0.00524892090486729 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00524892090486729 cfl multiplier : 0.46467294286434296        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4698e+04 |  512 |      1 | 3.483e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1044.2977134012224 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.225167653680355, dt = 0.00524892090486729 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.89 us    (1.3%)
   patch tree reduce : 864.00 ns  (0.3%)
   gen split merge   : 808.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 872.00 ns  (0.3%)
   LB compute        : 274.94 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1878.00 ns (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2862757733933528e-17,-5.1850613646403644e-17,1.6520293434022643e-18)
    sum a = (2.6615428611043158e-17,-4.519822016657571e-18,-7.234057103344683e-17)
    sum e = 2.5920008774464365
    sum de = 3.2526065174565133e-19
Info: CFL hydro = 0.007262426333659897 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007262426333659897 cfl multiplier : 0.6431152952428953        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0125e+04 |  512 |      1 | 2.544e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 742.7545419352758 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.230416574585222, dt = 0.007262426333659897 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.4%)
   patch tree reduce : 1169.00 ns (0.4%)
   gen split merge   : 579.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 831.00 ns  (0.3%)
   LB compute        : 271.74 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.55 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1889.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2136775959237233e-17,-5.227617655163136e-17,1.2690044327856586e-18)
    sum a = (7.284407452234908e-17,2.723602593457386e-17,5.547905884695226e-17)
    sum e = 2.592000933685985
    sum de = 8.402566836762659e-19
Info: CFL hydro = 0.00860337057296438 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00860337057296438 cfl multiplier : 0.7620768634952636         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9706e+04 |  512 |      1 | 2.598e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1006.2600362871414 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.237679000918882, dt = 0.00860337057296438 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.84 us    (1.4%)
   patch tree reduce : 937.00 ns  (0.3%)
   gen split merge   : 582.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 973.00 ns  (0.3%)
   LB compute        : 269.36 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1340537883763879e-17,-5.1648626781669594e-17,2.1494037018982002e-18)
    sum a = (-1.327844084686447e-17,-2.166235940626038e-17,-8.950652718997532e-17)
    sum e = 2.592000975928382
    sum de = -1.5111067779016718e-18
Info: CFL hydro = 0.009496015344751805 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009496015344751805 cfl multiplier : 0.8413845756635091        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9473e+04 |  512 |      1 | 2.629e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1177.9727676433201 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.246282371491846, dt = 0.009496015344751805 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.4%)
   patch tree reduce : 1025.00 ns (0.4%)
   gen split merge   : 514.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 944.00 ns  (0.3%)
   LB compute        : 274.03 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.63 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1853.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1937716440368895e-17,-5.223007085424641e-17,6.264520152621244e-19)
    sum a = (5.002834084499863e-18,-7.681355551625302e-18,-9.273831702572011e-17)
    sum e = 2.592001001621361
    sum de = -1.2874900798265365e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011439762117769437
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1926007056906052e-17,-5.201198358725095e-17,6.5352996451995e-19)
    sum a = (1.3937093666649414e-17,-5.929631785583922e-17,-6.946006270158733e-17)
    sum e = 2.592000810089493
    sum de = -2.236166980751353e-19
Info: CFL hydro = 0.005044575655147547 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005044575655147547 cfl multiplier : 0.4471281918878363        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4655e+04 |  512 |      1 | 3.494e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 978.5090847497852 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.255778386836598, dt = 0.005044575655147547 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.94 us    (1.3%)
   patch tree reduce : 1055.00 ns (0.3%)
   gen split merge   : 666.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1647.00 ns (0.5%)
   LB compute        : 287.65 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1440067643198049e-17,-5.252609870491642e-17,4.003145471359604e-19)
    sum a = (-8.156976071156674e-17,-1.0582940773717909e-16,5.0865561762591936e-17)
    sum e = 2.592000863867405
    sum de = 1.5517643593698782e-18
Info: CFL hydro = 0.007122547449454859 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007122547449454859 cfl multiplier : 0.6314187945918909        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9779e+04 |  512 |      1 | 2.589e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 701.5410694302534 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.260822962491745, dt = 0.007122547449454859 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 1049.00 ns (0.3%)
   gen split merge   : 648.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 882.00 ns  (0.3%)
   LB compute        : 288.67 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1992.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2347544861568415e-17,-5.362970809628942e-17,1.0875089891115852e-18)
    sum a = (3.660353270484862e-17,-9.475233098132918e-17,-2.09129588646384e-17)
    sum e = 2.59200091176502
    sum de = 1.7211709488207383e-18
Info: CFL hydro = 0.008507573253706819 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008507573253706819 cfl multiplier : 0.754279196394594         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9425e+04 |  512 |      1 | 2.636e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 972.8171417591825 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.2679455099412, dt = 0.008507573253706819 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.92 us    (1.3%)
   patch tree reduce : 955.00 ns  (0.3%)
   gen split merge   : 666.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1294.00 ns (0.4%)
   LB compute        : 282.10 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1969.00 ns (64.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1844041372666148e-17,-5.4245182564555124e-17,7.003674983713237e-19)
    sum a = (-1.206593418928703e-16,4.084232951839795e-17,-1.35828848168984e-17)
    sum e = 2.5920009479889576
    sum de = -1.0232158002831948e-18
Info: CFL hydro = 0.009431949216472573 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009431949216472573 cfl multiplier : 0.8361861309297293        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9928e+04 |  512 |      1 | 2.569e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1192.0642650235914 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.276453083194906, dt = 0.009431949216472573 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.96 us    (1.4%)
   patch tree reduce : 1039.00 ns (0.4%)
   gen split merge   : 637.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 804.00 ns  (0.3%)
   LB compute        : 277.24 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.368826926806399e-17,-5.3271840064206267e-17,6.118152859335701e-19)
    sum a = (1.6112111644872585e-17,7.11227951533111e-17,-3.405088710994875e-17)
    sum e = 2.5920009711342367
    sum de = 1.8973538018496328e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011099051940480253
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.290374057605348e-17,-5.320012009049635e-17,5.210675640965334e-19)
    sum a = (4.378138476757165e-17,-4.971804218323328e-17,1.0486923829322591e-16)
    sum e = 2.592000810533037
    sum de = -8.538092108323347e-19
Info: CFL hydro = 0.005026461048292198 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005026461048292198 cfl multiplier : 0.44539537697657644       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4639e+04 |  512 |      1 | 3.498e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 970.8123486382304 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.285885032411379, dt = 0.005026461048292198 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.4%)
   patch tree reduce : 1404.00 ns (0.5%)
   gen split merge   : 1069.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 292.05 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2640279448139502e-17,-5.402855897049252e-17,1.6993242750451554e-18)
    sum a = (-1.1633272470334966e-16,1.3511457577775054e-16,-8.00687641189235e-17)
    sum e = 2.5920008558159333
    sum de = 2.290377089375628e-18
Info: CFL hydro = 0.0071147766191464274 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0071147766191464274 cfl multiplier : 0.6302635846510509       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9722e+04 |  512 |      1 | 2.596e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 697.0320103494348 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.290911493459671, dt = 0.0071147766191464274 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.5%)
   patch tree reduce : 1028.00 ns (0.3%)
   gen split merge   : 753.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 934.00 ns  (0.3%)
   LB compute        : 286.98 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1910.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3594594200361244e-17,-5.248145668046433e-17,7.040266807034623e-19)
    sum a = (-5.820734519379477e-17,-1.8486774611137236e-16,3.852387159275494e-17)
    sum e = 2.592000897991843
    sum de = 1.6940658945086007e-19
Info: CFL hydro = 0.008506725414645639 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008506725414645639 cfl multiplier : 0.753509056434034         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9054e+04 |  512 |      1 | 2.687e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 953.1967285772929 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.298026270078817, dt = 0.008506725414645639 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.5%)
   patch tree reduce : 911.00 ns  (0.3%)
   gen split merge   : 688.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 908.00 ns  (0.3%)
   LB compute        : 272.91 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4238610290817633e-17,-5.571031917034341e-17,1.4797733351168408e-18)
    sum a = (1.372339741845252e-17,-1.5120326865569745e-16,6.93429688669589e-17)
    sum e = 2.592000932163766
    sum de = -5.21772295508649e-19
Info: CFL hydro = 0.00943276049897938 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00943276049897938 cfl multiplier : 0.835672704289356          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9397e+04 |  512 |      1 | 2.640e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1160.196806750231 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.306532995493463, dt = 0.00943276049897938 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.6%)
   patch tree reduce : 981.00 ns  (0.3%)
   gen split merge   : 679.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 982.00 ns  (0.3%)
   LB compute        : 278.49 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1903.00 ns (64.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3817072486155268e-17,-5.667195228722943e-17,2.194045726350291e-18)
    sum a = (1.1191828713785766e-16,7.043194152900334e-17,1.0760923402353128e-17)
    sum e = 2.5920009576212912
    sum de = 1.599198204416119e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01068000801100613
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.314378293704177e-17,-5.54907682304151e-17,1.908629504443482e-18)
    sum a = (-5.597085295239168e-17,-9.492797173327184e-17,7.6216376959648e-17)
    sum e = 2.5920008121202787
    sum de = -1.3213713977167085e-18
Info: CFL hydro = 0.0050262787878885915 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0050262787878885915 cfl multiplier : 0.4452242347631186       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4583e+04 |  512 |      1 | 3.511e-02 | 0.1% |   2.3% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 967.1970631973714 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.315965755992442, dt = 0.0050262787878885915 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.3%)
   patch tree reduce : 1029.00 ns (0.3%)
   gen split merge   : 739.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1540.00 ns (0.5%)
   LB compute        : 304.54 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.61 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1969.00 ns (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4215191523891945e-17,-5.68636934414335e-17,2.611192512214089e-18)
    sum a = (4.653308988133986e-17,-1.2894958538456346e-16,2.1720906323574596e-17)
    sum e = 2.5920008529765433
    sum de = -2.3445871979999033e-18
Info: CFL hydro = 0.007114605827324257 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007114605827324257 cfl multiplier : 0.6301494898420791        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9346e+04 |  512 |      1 | 2.647e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 683.7068110440822 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.320992034780331, dt = 0.007114605827324257 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1503.00 ns (0.5%)
   gen split merge   : 786.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 919.00 ns  (0.3%)
   LB compute        : 272.64 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3612158275555508e-17,-5.773896985528104e-17,2.6975492152525595e-18)
    sum a = (-6.552570985807193e-17,-3.557896165184982e-17,1.4352191310407215e-16)
    sum e = 2.592000894561566
    sum de = -6.776263578034403e-19
Info: CFL hydro = 0.008508639150219552 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008508639150219552 cfl multiplier : 0.7534329932280528        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9679e+04 |  512 |      1 | 2.602e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 984.4535804407718 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.328106640607655, dt = 0.008508639150219552 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.5%)
   patch tree reduce : 970.00 ns  (0.3%)
   gen split merge   : 721.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1500.00 ns (0.5%)
   LB compute        : 286.67 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1840.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4788951313571274e-17,-5.782679023125236e-17,4.367600031640606e-18)
    sum a = (-8.390944189473615e-17,3.585998685495806e-17,-6.064289695406622e-17)
    sum e = 2.592000931817163
    sum de = -1.6940658945086007e-19
Info: CFL hydro = 0.009441266354862636 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009441266354862636 cfl multiplier : 0.8356219954853685        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9691e+04 |  512 |      1 | 2.600e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1178.0509853059818 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.336615279757875, dt = 0.009441266354862636 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.5%)
   patch tree reduce : 1244.00 ns (0.4%)
   gen split merge   : 749.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 873.00 ns  (0.3%)
   LB compute        : 275.91 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.41 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1829.00 ns (64.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5547133892790387e-17,-5.706128928736898e-17,2.9156364822480185e-18)
    sum a = (3.943720350285673e-17,2.7432889944042916e-17,-9.21996853864293e-17)
    sum e = 2.5920009637161536
    sum de = -1.6805133673525319e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010195518497385956
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.490604514819971e-17,-5.697054156553194e-17,2.7912242829553067e-18)
    sum a = (7.458877265831277e-17,3.768445516576235e-17,-6.556083800846047e-17)
    sum e = 2.5920008144593036
    sum de = -2.778268066994105e-19
Info: CFL hydro = 0.005034401924055156 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005034401924055156 cfl multiplier : 0.4452073318284562        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4613e+04 |  512 |      1 | 3.504e-02 | 0.0% |   2.3% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 970.1011199193576 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.346056546112737, dt = 0.005034401924055156 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 970.00 ns  (0.3%)
   gen split merge   : 714.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1467.00 ns (0.5%)
   LB compute        : 295.74 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1956.00 ns (64.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.452841753152301e-17,-5.706421663323468e-17,2.5716733430269922e-18)
    sum a = (-9.414344304126131e-18,6.598603499545497e-17,6.54086160234435e-17)
    sum e = 2.5920008563093493
    sum de = 8.267041565201971e-19
Info: CFL hydro = 0.007125707152129507 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007125707152129507 cfl multiplier : 0.6301382212189708        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9245e+04 |  512 |      1 | 2.660e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 681.222652633598 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 6.351090948036792, dt = 0.007125707152129507 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.4%)
   patch tree reduce : 1553.00 ns (0.5%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 918.00 ns  (0.3%)
   LB compute        : 291.62 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.71 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.47684598925113e-17,-5.631774343747841e-17,3.3664477455674913e-18)
    sum a = (3.1568497815825936e-17,2.6059232896558092e-17,-8.477593627098656e-17)
    sum e = 2.592000902189175
    sum de = -2.6291902682773483e-18
Info: CFL hydro = 0.008516938438673675 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008516938438673675 cfl multiplier : 0.7534254808126472        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8416e+04 |  512 |      1 | 2.780e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 922.7128846230653 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.358216655188921, dt = 0.008516938438673675 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.5%)
   patch tree reduce : 1084.00 ns (0.3%)
   gen split merge   : 629.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 919.00 ns  (0.3%)
   LB compute        : 293.28 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (68.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4373268200640332e-17,-5.627676059535847e-17,2.098906985714688e-18)
    sum a = (-8.40031169624389e-17,-2.693158196453993e-19,2.0011336337999453e-17)
    sum e = 2.5920009453626784
    sum de = -1.832979297858306e-18
Info: CFL hydro = 0.00943873944298189 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00943873944298189 cfl multiplier : 0.8356169872084314         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9281e+04 |  512 |      1 | 2.656e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1154.6115366122085 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.366733593627595, dt = 0.00943873944298189 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.4%)
   patch tree reduce : 1534.00 ns (0.5%)
   gen split merge   : 691.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 941.00 ns  (0.3%)
   LB compute        : 300.54 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1963.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5640808960493135e-17,-5.636604464426265e-17,2.7077949257825475e-18)
    sum a = (4.730590918988753e-17,-8.2199871909161e-17,-1.2353399553299837e-17)
    sum e = 2.5920009833296263
    sum de = 2.002385887309166e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010563664753300932
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4967519411379636e-17,-5.684612936623923e-17,2.5526455948998717e-18)
    sum a = (2.5044029350329566e-16,-1.5437651157412802e-16,-6.70245109413159e-17)
    sum e = 2.592000816783389
    sum de = -4.2690460541616737e-19
Info: CFL hydro = 0.005025561088903703 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005025561088903703 cfl multiplier : 0.44520566240281045       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4339e+04 |  512 |      1 | 3.571e-02 | 0.0% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 951.630152991807 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 6.376172333070577, dt = 0.005025561088903703 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 1049.00 ns (0.3%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 931.00 ns  (0.3%)
   LB compute        : 293.30 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1831.00 ns (64.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2760300628633647e-17,-5.76189486747869e-17,1.9203388879063254e-18)
    sum a = (5.695444116327053e-17,-1.0933051339256927e-16,-1.2495961296959956e-16)
    sum e = 2.5920008633362537
    sum de = -1.3315357930837601e-18
Info: CFL hydro = 0.007110762465175528 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007110762465175528 cfl multiplier : 0.6301371082685403        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9901e+04 |  512 |      1 | 2.573e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 703.205314505756 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 6.381197894159481, dt = 0.007110762465175528 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.5%)
   patch tree reduce : 995.00 ns  (0.3%)
   gen split merge   : 735.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1018.00 ns (0.3%)
   LB compute        : 275.39 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1881.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.283641162114213e-17,-5.844006919011879e-17,9.191866018332106e-19)
    sum a = (-1.2037246199803065e-17,1.368007269964e-16,7.604951824530248e-17)
    sum e = 2.5920009149430205
    sum de = 7.962109704190423e-19
Info: CFL hydro = 0.008499308969307562 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008499308969307562 cfl multiplier : 0.7534247388456935        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9278e+04 |  512 |      1 | 2.656e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 963.8696048897957 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.388308656624656, dt = 0.008499308969307562 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.5%)
   patch tree reduce : 1192.00 ns (0.4%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 966.00 ns  (0.3%)
   LB compute        : 287.20 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1919.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3351624493507242e-17,-5.634555322320267e-17,2.3008938504487377e-18)
    sum a = (-5.615820308779717e-17,-1.6217496096038177e-17,1.0119615106822521e-16)
    sum e = 2.5920009631002725
    sum de = -7.030373462210693e-19
Info: CFL hydro = 0.009425009266780278 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009425009266780278 cfl multiplier : 0.8356164925637956        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8956e+04 |  512 |      1 | 2.701e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1132.849355902683 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.396807965593964, dt = 0.009425009266780278 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.97 us    (1.6%)
   patch tree reduce : 1028.00 ns (0.3%)
   gen split merge   : 684.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 978.00 ns  (0.3%)
   LB compute        : 286.68 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1828.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4036623426083584e-17,-5.72149749453188e-17,3.3401016327760934e-18)
    sum a = (2.0655352428455842e-17,-2.964815892791961e-17,-3.484273416662353e-18)
    sum e = 2.5920010040520873
    sum de = -1.819426770702237e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010045459338498201
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3590203181562676e-17,-5.734524183634294e-17,2.8570895649338013e-18)
    sum a = (5.615820308779717e-17,-1.049160758270773e-17,1.841373733178775e-17)
    sum e = 2.5920008183695993
    sum de = 1.2709729373550777e-18
Info: CFL hydro = 0.005022673588780467 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005022673588780467 cfl multiplier : 0.44520549752126515       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.3498e+04 |  512 |      1 | 3.793e-02 | 0.0% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 894.5287653305616 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.406232974860744, dt = 0.005022673588780467 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.5%)
   patch tree reduce : 1394.00 ns (0.5%)
   gen split merge   : 678.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 964.00 ns  (0.3%)
   LB compute        : 292.33 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1863.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3154028647571758e-17,-5.716228271973601e-17,3.1059139635192244e-18)
    sum a = (4.6369158512860054e-18,4.7013174603316444e-17,1.1867460139591834e-17)
    sum e = 2.59200087047416
    sum de = 7.242131699024268e-19
Info: CFL hydro = 0.007110005450317481 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007110005450317481 cfl multiplier : 0.6301369983475101        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9320e+04 |  512 |      1 | 2.650e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 682.2828581690344 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.411255648449525, dt = 0.007110005450317481 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.97 us    (1.4%)
   patch tree reduce : 1671.00 ns (0.6%)
   gen split merge   : 787.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 953.00 ns  (0.3%)
   LB compute        : 276.07 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.311158213251895e-17,-5.690906730235201e-17,3.0590764296678507e-18)
    sum a = (7.508056676375219e-17,8.250431587919493e-17,1.7315250795679747e-17)
    sum e = 2.592000926270813
    sum de = 1.6788193014580233e-18
Info: CFL hydro = 0.008504022686410841 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008504022686410841 cfl multiplier : 0.7534246655650069        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9402e+04 |  512 |      1 | 2.639e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 969.9365972509592 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.418365653899842, dt = 0.008504022686410841 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 976.00 ns  (0.3%)
   gen split merge   : 1253.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 1179.00 ns (0.4%)
   LB compute        : 281.59 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1762.00 ns (64.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2360717917964114e-17,-5.585375911776324e-17,3.3196102117161173e-18)
    sum a = (1.7025443554974374e-17,3.508131285467897e-17,3.215982168069953e-17)
    sum e = 2.592000976174751
    sum de = -6.776263578034403e-21
Info: CFL hydro = 0.009437616691453179 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009437616691453179 cfl multiplier : 0.8356164437100047        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9506e+04 |  512 |      1 | 2.625e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1166.352567323152 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.426869676586254, dt = 0.009437616691453179 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.5%)
   patch tree reduce : 898.00 ns  (0.3%)
   gen split merge   : 728.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 278.72 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1968.00 ns (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2419264835278332e-17,-5.579594403691546e-17,3.6826010990642645e-18)
    sum a = (-1.0690667101576068e-16,5.177889367269373e-17,-3.00228591987306e-17)
    sum e = 2.592001015698132
    sum de = 7.826584432629735e-19
Info: CFL hydro = 0.010066020834421206 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010066020834421206 cfl multiplier : 0.8904109624733364        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9576e+04 |  512 |      1 | 2.615e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1299.0323729482307 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.436307293277707, dt = 0.010066020834421206 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.4%)
   patch tree reduce : 998.00 ns  (0.3%)
   gen split merge   : 698.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1042.00 ns (0.4%)
   LB compute        : 273.97 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1877.00 ns (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.420714132276124e-17,-5.521047486377328e-17,3.0385850086078747e-18)
    sum a = (2.39269541679743e-16,1.2461125881157997e-16,2.5450344956490234e-17)
    sum e = 2.5920010442668073
    sum de = -1.1756817307889689e-18
Info: CFL hydro = 0.01049253365332349 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01049253365332349 cfl multiplier : 0.9269406416488909         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9779e+04 |  512 |      1 | 2.589e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1399.8721261441553 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.446373314112129, dt = 0.01049253365332349 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.5%)
   patch tree reduce : 1465.00 ns (0.5%)
   gen split merge   : 691.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 289.23 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1904.00 ns (64.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.869912504477384e-18,-5.369447562356827e-17,3.60063541482436e-18)
    sum a = (-1.1229298740866867e-16,2.098321516541546e-17,-1.3114509478384661e-17)
    sum e = 2.5920010628057244
    sum de = -1.1011428314305904e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010451164739370642
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1793910574715849e-17,-5.406405303911427e-17,3.400112223023166e-18)
    sum a = (-5.3980257763708294e-17,-9.66960886361612e-17,6.323067069935462e-18)
    sum e = 2.5920008208697256
    sum de = 3.2187251995663413e-19
Info: CFL hydro = 0.005379238274823958 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005379238274823958 cfl multiplier : 0.47564688054963034       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4701e+04 |  512 |      1 | 3.483e-02 | 0.0% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1084.6077829285805 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.456865847765452, dt = 0.005379238274823958 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.4%)
   patch tree reduce : 1048.00 ns (0.3%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1672.00 ns (0.5%)
   LB compute        : 297.21 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.171048121754309e-17,-5.51607099840562e-17,3.561116245637264e-18)
    sum a = (-1.3053620684377875e-16,8.491644887254068e-17,7.286749328927477e-17)
    sum e = 2.592000883805609
    sum de = -3.049318610115481e-20
Info: CFL hydro = 0.007351773045027944 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007351773045027944 cfl multiplier : 0.6504312536997535        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9518e+04 |  512 |      1 | 2.623e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 738.2195429735166 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.4622450860402765, dt = 0.007351773045027944 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.81 us    (1.3%)
   patch tree reduce : 1089.00 ns (0.4%)
   gen split merge   : 766.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 867.00 ns  (0.3%)
   LB compute        : 272.76 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.67 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 14.73 us   (93.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2915312740178867e-17,-5.411894077409635e-17,4.27685230980357e-18)
    sum a = (-1.0229317393140035e-16,-1.604653909748066e-16,-8.724661618164653e-17)
    sum e = 2.5920009368211523
    sum de = 3.7269449679189215e-20
Info: CFL hydro = 0.00866318681723297 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00866318681723297 cfl multiplier : 0.7669541691331689         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9380e+04 |  512 |      1 | 2.642e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1001.7816497386058 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.469596859085304, dt = 0.00866318681723297 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1178.00 ns (0.4%)
   gen split merge   : 698.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1147.00 ns (0.4%)
   LB compute        : 273.49 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1858.00 ns (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.364838418064368e-17,-5.637446076362657e-17,2.934664230375139e-18)
    sum a = (-8.894447678375882e-17,6.892143106229653e-17,9.999813477268304e-17)
    sum e = 2.592000978638571
    sum de = -2.744386749103933e-19
Info: CFL hydro = 0.009534990254396436 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009534990254396436 cfl multiplier : 0.8446361127554459        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0142e+04 |  512 |      1 | 2.542e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1226.9280300217185 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.4782600459025375, dt = 0.009534990254396436 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.5%)
   patch tree reduce : 1212.00 ns (0.4%)
   gen split merge   : 702.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 811.00 ns  (0.3%)
   LB compute        : 278.57 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1974.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4574523228907955e-17,-5.4808330725471256e-17,4.73790928365303e-18)
    sum a = (-2.1147146533895267e-17,7.423749115442745e-18,-9.387412722161592e-17)
    sum e = 2.5920010067235224
    sum de = -3.3881317890172014e-20
Info: CFL hydro = 0.010115221906323411 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010115221906323411 cfl multiplier : 0.8964240751702972        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9273e+04 |  512 |      1 | 2.657e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1292.1185848756384 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.487795036156934, dt = 0.010115221906323411 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1201.00 ns (0.4%)
   gen split merge   : 965.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 285.72 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1807.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4449745111382028e-17,-5.4988728414445684e-17,2.876117313060922e-18)
    sum a = (1.429481533143928e-16,-8.992806499463767e-17,-1.3536047283047026e-17)
    sum e = 2.5920010228839456
    sum de = 2.507217523872729e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011412429646572003
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.364179765244583e-17,-5.552736005373648e-17,3.2288624898790806e-18)
    sum a = (-1.3699978651526834e-17,8.64855062565617e-17,8.869857973103912e-17)
    sum e = 2.5920008203021108
    sum de = 1.1655173354219173e-18
Info: CFL hydro = 0.005251939121541544 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005251939121541544 cfl multiplier : 0.4654746917234324        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4820e+04 |  512 |      1 | 3.455e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1054.0402415701722 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.497910258063257, dt = 0.0020897419367429393 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.84 us    (1.2%)
   patch tree reduce : 1205.00 ns (0.4%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1700.00 ns (0.5%)
   LB compute        : 281.24 us  (90.3%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.432935801265467e-17,-5.4380572310844255e-17,3.931425497649688e-18)
    sum a = (9.81246334186281e-18,1.3334645887486118e-16,4.5608048587775226e-17)
    sum e = 2.5920008298796002
    sum de = -3.049318610115481e-19
Info: CFL hydro = 0.007262182046888402 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007262182046888402 cfl multiplier : 0.6436497944822883        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9330e+04 |  512 |      1 | 2.649e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 284.0282264790407 (tsim/hr)                             [sph::Model][rank=0]
Info: iteration since start : 874                                                     [SPH][rank=0]
Info: time since start : 1763.1363231060002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14982363877132265 max=0.15018518974075232 delta=0.0003615509694296637
Number of particle pairs: 130816
Distance min=0.147316 max=1.990592 mean=0.806356
---------------- t = 6.5, dt = 0.007262182046888402 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 10.04 us   (1.8%)
   patch tree reduce : 1896.00 ns (0.3%)
   gen split merge   : 486.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 882.00 ns  (0.2%)
   LB compute        : 531.22 us  (95.7%)
   LB move op cnt    : 0
   LB apply          : 3.84 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (81.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4276665787071874e-17,-5.3301113522863373e-17,4.221232738355063e-18)
    sum a = (1.3615671090594362e-16,7.5244498132232e-17,-2.866457071704076e-17)
    sum e = 2.5920009221216853
    sum de = 6.437450399132683e-19
Info: CFL hydro = 0.008602361038832449 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008602361038832449 cfl multiplier : 0.7624331963215255        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6721e+04 |  512 |      1 | 3.062e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 853.8075251282766 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.5072621820468886, dt = 0.008602361038832449 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.5%)
   patch tree reduce : 1694.00 ns (0.6%)
   gen split merge   : 674.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 276.15 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.68 us    (71.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2489521136055392e-17,-5.2979837314101604e-17,3.7001651742585295e-18)
    sum a = (-7.406185040248481e-18,-1.687087969326484e-16,3.188465116932271e-17)
    sum e = 2.592000958243981
    sum de = -1.0503208545953324e-18
Info: CFL hydro = 0.00949779476873746 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00949779476873746 cfl multiplier : 0.8416221308810169         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9081e+04 |  512 |      1 | 2.683e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1154.09828302316 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 6.515864543085721, dt = 0.00949779476873746 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1392.00 ns (0.5%)
   gen split merge   : 699.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 985.00 ns  (0.3%)
   LB compute        : 286.55 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3397730190892187e-17,-5.568250938461916e-17,4.278315982736424e-18)
    sum a = (-1.2245087756268536e-17,-2.8336707980081143e-18,1.0189505489366369e-16)
    sum e = 2.5920009829493327
    sum de = 1.4907779871675686e-19
Info: CFL hydro = 0.010098071668395808 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010098071668395808 cfl multiplier : 0.8944147539206778        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9602e+04 |  512 |      1 | 2.612e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1309.0589137271095 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.5253623378544585, dt = 0.010098071668395808 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.5%)
   patch tree reduce : 1208.00 ns (0.4%)
   gen split merge   : 727.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1252.00 ns (0.4%)
   LB compute        : 283.99 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3435785687146428e-17,-5.494774557232573e-17,5.598548968172024e-18)
    sum a = (-1.1288723861940797e-16,-1.4477481713459638e-16,-5.752820095294986e-17)
    sum e = 2.5920009987008545
    sum de = -4.946672411965114e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011452524770387254
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3989054055765782e-17,-5.555224249359503e-17,4.778892125772982e-18)
    sum a = (1.376745397373147e-16,1.4043063586988146e-16,-8.141534321715049e-17)
    sum e = 2.592000821155085
    sum de = 1.1519648082658485e-19
Info: CFL hydro = 0.0052520704331400015 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0052520704331400015 cfl multiplier : 0.4648049179735592       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4179e+04 |  512 |      1 | 3.611e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1006.7116682806825 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.535460409522854, dt = 0.0052520704331400015 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.08 us    (1.3%)
   patch tree reduce : 1392.00 ns (0.4%)
   gen split merge   : 690.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 296.53 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2062860476128034e-17,-5.346358121841033e-17,4.268802108672864e-18)
    sum a = (-5.989056906657853e-17,6.780903963332641e-17,-4.655650864826555e-17)
    sum e = 2.5920008687214144
    sum de = 1.3349239248727773e-18
Info: CFL hydro = 0.007271084955512884 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007271084955512884 cfl multiplier : 0.6432032786490395        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8770e+04 |  512 |      1 | 2.728e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 693.1458969586192 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.540712479955994, dt = 0.007271084955512884 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.5%)
   patch tree reduce : 1389.00 ns (0.5%)
   gen split merge   : 765.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 946.00 ns  (0.3%)
   LB compute        : 287.75 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3010588700151925e-17,-5.306838952653936e-17,3.945330390511814e-18)
    sum a = (-6.64858793020251e-17,1.0986914503186008e-16,7.862850995299376e-17)
    sum e = 2.592000910937169
    sum de = -1.294266343404571e-18
Info: CFL hydro = 0.008615896241820421 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008615896241820421 cfl multiplier : 0.7621355190993597        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8758e+04 |  512 |      1 | 2.729e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 959.0187227626632 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.547983564911507, dt = 0.008615896241820421 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.5%)
   patch tree reduce : 1477.00 ns (0.5%)
   gen split merge   : 688.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 284.97 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1963.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3563857068771279e-17,-5.197795319156206e-17,5.167497289446099e-18)
    sum a = (1.7452836051368158e-17,-7.878073193801072e-17,1.7600374282999986e-16)
    sum e = 2.5920009460739415
    sum de = -1.5720931501039814e-18
Info: CFL hydro = 0.009505061638586285 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009505061638586285 cfl multiplier : 0.8414236793995732        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9459e+04 |  512 |      1 | 2.631e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1178.852940815208 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.556599461153327, dt = 0.009505061638586285 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.3%)
   patch tree reduce : 1329.00 ns (0.4%)
   gen split merge   : 757.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 947.00 ns  (0.3%)
   LB compute        : 297.74 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1969.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2944723418173432e-17,-5.348992733120173e-17,7.253231218765088e-18)
    sum a = (-5.612307493740865e-17,-1.008763385323963e-16,2.482389294122811e-17)
    sum e = 2.592000973160496
    sum de = 6.776263578034403e-20
Info: CFL hydro = 0.01009565765993405 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01009565765993405 cfl multiplier : 0.8942824529330489         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8107e+04 |  512 |      1 | 2.828e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1210.1295404154803 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.566104522791914, dt = 0.01009565765993405 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1966.00 ns (0.7%)
   gen split merge   : 646.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1048.00 ns (0.4%)
   LB compute        : 279.12 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1966.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.400332486686112e-17,-5.4722339940665996e-17,6.769487314456368e-18)
    sum a = (-1.0659051766226391e-16,1.0903192411426676e-16,2.3067485421801592e-18)
    sum e = 2.5920009945833558
    sum de = 4.1674021004911577e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010665840909942388
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.426202905774332e-17,-5.3659713391412954e-17,6.683862447884326e-18)
    sum a = (2.3559279527241016e-17,1.060518860229731e-16,3.7317805096082065e-17)
    sum e = 2.592000824212399
    sum de = 1.9989977555201488e-19
Info: CFL hydro = 0.00524518124154411 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00524518124154411 cfl multiplier : 0.4647608176443496         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4343e+04 |  512 |      1 | 3.570e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1018.1660448801669 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.576200180451848, dt = 0.00524518124154411 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 1365.00 ns (0.5%)
   gen split merge   : 755.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 830.00 ns  (0.3%)
   LB compute        : 274.92 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1928.00 ns (12.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3373579587500072e-17,-5.318109234236923e-17,7.091861277917777e-18)
    sum a = (-6.353511466938855e-17,-1.4689421554137104e-16,1.435921694048492e-16)
    sum e = 2.5920008694972787
    sum de = 4.675621868843738e-19
Info: CFL hydro = 0.007257658283379231 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007257658283379231 cfl multiplier : 0.6431738784295664        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0091e+04 |  512 |      1 | 2.548e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 740.976444244285 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 6.581445361693392, dt = 0.007257658283379231 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1848.00 ns (0.6%)
   gen split merge   : 689.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 868.00 ns  (0.3%)
   LB compute        : 278.32 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1867.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.406406729357462e-17,-5.4840897448227286e-17,8.406239571621953e-18)
    sum a = (7.168484555952759e-17,-1.9569892581450253e-16,-1.8430569570515586e-17)
    sum e = 2.59200091337146
    sum de = 4.607859233063394e-19
Info: CFL hydro = 0.008596784250048022 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008596784250048022 cfl multiplier : 0.7621159189530443        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0227e+04 |  512 |      1 | 2.531e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1032.2163968648688 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.588703019976771, dt = 0.008596784250048022 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.4%)
   patch tree reduce : 1733.00 ns (0.6%)
   gen split merge   : 1063.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 980.00 ns  (0.3%)
   LB compute        : 284.12 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.73 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2939692042466741e-17,-5.675977266320075e-17,7.732035226925421e-18)
    sum a = (-1.0154377338977838e-16,8.20388678865469e-17,-3.9882160074444785e-17)
    sum e = 2.592000952848263
    sum de = 1.6144447974666964e-18
Info: CFL hydro = 0.009487806986092992 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009487806986092992 cfl multiplier : 0.841410612635363         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9627e+04 |  512 |      1 | 2.609e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1186.358478610472 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.597299804226819, dt = 0.009487806986092992 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.5%)
   patch tree reduce : 950.00 ns  (0.3%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 769.00 ns  (0.3%)
   LB compute        : 270.53 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1979.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.461660382572755e-17,-5.475014972639025e-17,7.257813772888852e-18)
    sum a = (-2.5784062385181273e-17,7.701755493126974e-17,2.943739002558843e-17)
    sum e = 2.592000986324028
    sum de = 2.244637310223896e-18
Info: CFL hydro = 0.010081860122989877 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010081860122989877 cfl multiplier : 0.8942737417569088        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8546e+04 |  512 |      1 | 2.761e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1237.197167710107 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.606787611212912, dt = 0.010081860122989877 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.5%)
   patch tree reduce : 1326.00 ns (0.5%)
   gen split merge   : 713.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1161.00 ns (0.4%)
   LB compute        : 271.88 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1993.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.446328408601094e-17,-5.4059296102082486e-17,7.846384674804752e-18)
    sum a = (-4.0701816916843827e-17,3.1591916582751624e-17,7.698919626819567e-17)
    sum e = 2.5920010145270673
    sum de = -3.7947076036992655e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01047853128711534
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4530247122689078e-17,-5.425689194801797e-17,8.067399287665922e-18)
    sum a = (1.259929660601955e-16,8.174613329997582e-17,-4.045591986412411e-17)
    sum e = 2.5920008283449687
    sum de = 1.0554030522788582e-18
Info: CFL hydro = 0.005240231175795107 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005240231175795107 cfl multiplier : 0.46475791391896965       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4139e+04 |  512 |      1 | 3.621e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1002.2856679369171 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.616869471335902, dt = 0.005240231175795107 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.5%)
   patch tree reduce : 1216.00 ns (0.4%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1418.00 ns (0.5%)
   LB compute        : 276.68 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1999.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2984242587360528e-17,-5.36714227748758e-17,7.36209189314621e-18)
    sum a = (3.0411610729697004e-16,1.4918925470008837e-16,-9.287882962727422e-17)
    sum e = 2.5920008777963988
    sum de = -8.82608331038981e-19
Info: CFL hydro = 0.0072523874679088106 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0072523874679088106 cfl multiplier : 0.6431719426126464       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9632e+04 |  512 |      1 | 2.608e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 723.3356693031895 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.622109702511698, dt = 0.0072523874679088106 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (0.1%)
   patch tree reduce : 1359.00 ns (0.0%)
   gen split merge   : 697.00 ns  (0.0%)
   split / merge op  : 0/0
   apply split merge : 838.00 ns  (0.0%)
   LB compute        : 4.31 ms    (99.6%)
   LB move op cnt    : 0
   LB apply          : 3.81 us    (0.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.28 us    (75.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.043964719359136e-17,-5.2308743274387395e-17,6.529993830817899e-18)
    sum a = (-1.5151942200919423e-17,2.143402642873493e-17,-5.35235918086574e-17)
    sum e = 2.592000927082696
    sum de = -1.834461605516001e-18
Info: CFL hydro = 0.00859536416125289 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00859536416125289 cfl multiplier : 0.7621146284084309         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7027e+04 |  512 |      1 | 3.007e-02 | 0.1% |   1.5% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 868.2383508207495 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.629362089979606, dt = 0.00859536416125289 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.62 us    (1.2%)
   patch tree reduce : 1238.00 ns (0.4%)
   gen split merge   : 852.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 784.00 ns  (0.3%)
   LB compute        : 288.55 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1566675351890044e-17,-5.250780279325573e-17,6.176699776649919e-18)
    sum a = (5.419102666603948e-17,9.747476263644027e-17,1.0678957718113224e-17)
    sum e = 2.5920009716107875
    sum de = 1.3298417271892515e-19
Info: CFL hydro = 0.00948917912596595 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00948917912596595 cfl multiplier : 0.8414097522722873         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0247e+04 |  512 |      1 | 2.529e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1223.661845339698 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.637957454140859, dt = 0.00948917912596595 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.77 us    (1.3%)
   patch tree reduce : 1142.00 ns (0.4%)
   gen split merge   : 650.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 749.00 ns  (0.3%)
   LB compute        : 277.52 us  (95.5%)
   LB move op cnt    : 0
   LB apply          : 2.14 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 14.18 us   (92.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0794587879808804e-17,-5.130027262365e-17,6.579209833185162e-18)
    sum a = (-4.10999359545805e-17,5.721204759945309e-17,7.793180163695457e-17)
    sum e = 2.592001008199147
    sum de = -7.030373462210693e-19
Info: CFL hydro = 0.010085657047591094 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010085657047591094 cfl multiplier : 0.8942731681815248        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0065e+04 |  512 |      1 | 2.552e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1338.7825991911122 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.647446633266825, dt = 0.010085657047591094 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.73 us    (1.3%)
   patch tree reduce : 836.00 ns  (0.3%)
   gen split merge   : 755.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 711.00 ns  (0.2%)
   LB compute        : 276.03 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 2.27 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1725483865104857e-17,-5.08962988941819e-17,7.676232696360307e-18)
    sum a = (3.0889353574981015e-17,-3.864096542738338e-18,-1.3255022079938783e-17)
    sum e = 2.592001036616966
    sum de = -9.351243737687476e-19
Info: CFL hydro = 0.010486006095832872 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010486006095832872 cfl multiplier : 0.9295154454543498        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9492e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1382.2456907979306 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.657532290314416, dt = 0.010486006095832872 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.4%)
   patch tree reduce : 845.00 ns  (0.3%)
   gen split merge   : 634.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1178.00 ns (0.4%)
   LB compute        : 278.28 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1980.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1031702894931383e-17,-5.11656147138273e-17,7.060026391628171e-18)
    sum a = (4.730590918988753e-18,3.0994738026146604e-17,5.66499971932366e-17)
    sum e = 2.5920010574192696
    sum de = -1.7957098481791167e-19
Info: CFL hydro = 0.010756886184229588 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010756886184229588 cfl multiplier : 0.9530102969695665        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9390e+04 |  512 |      1 | 2.641e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1429.5853413053997 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.668018296410248, dt = 0.010756886184229588 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.5%)
   patch tree reduce : 1321.00 ns (0.4%)
   gen split merge   : 676.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 745.00 ns  (0.2%)
   LB compute        : 287.84 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1144405710761252e-17,-5.07352948715678e-17,8.138753343142624e-18)
    sum a = (-1.608166724786919e-16,1.08827009903667e-16,-2.357098891070386e-17)
    sum e = 2.5920010713232444
    sum de = 1.8939656700606156e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010409631481106893
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2084083733654439e-17,-5.03313211420997e-17,7.724533903144537e-18)
    sum a = (2.1076890233118207e-17,4.222403676701347e-17,-1.5151942200919423e-17)
    sum e = 2.5920008343333465
    sum de = 7.792703114739563e-19
Info: CFL hydro = 0.005466677013210671 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005466677013210671 cfl multiplier : 0.48433676565652223       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4210e+04 |  512 |      1 | 3.603e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1074.8004153019801 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.678775182594478, dt = 0.005466677013210671 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.5%)
   patch tree reduce : 1069.00 ns (0.4%)
   gen split merge   : 684.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 846.00 ns  (0.3%)
   LB compute        : 285.97 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0927782116698647e-17,-5.043963293913101e-17,7.63085883544179e-18)
    sum a = (-5.73759789679329e-18,6.636878546739666e-17,-1.6290679742680946e-17)
    sum e = 2.5920008947275455
    sum de = -5.861467994999758e-19
Info: CFL hydro = 0.007402131419553036 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007402131419553036 cfl multiplier : 0.6562245104376815        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8874e+04 |  512 |      1 | 2.713e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 725.4768461280314 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.684241859607689, dt = 0.007402131419553036 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 1079.00 ns (0.3%)
   gen split merge   : 673.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 816.00 ns  (0.3%)
   LB compute        : 292.94 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.104194860546137e-17,-4.9862945803585966e-17,7.534988258339759e-18)
    sum a = (1.1887366091478668e-16,9.796070205014829e-17,-9.33823331161765e-19)
    sum e = 2.592000944812788
    sum de = 2.032879073410321e-18
Info: CFL hydro = 0.008688509521590752 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008688509521590752 cfl multiplier : 0.7708163402917876        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9389e+04 |  512 |      1 | 2.641e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1009.0993151911953 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.6916439910272425, dt = 0.008688509521590752 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.96 us    (1.4%)
   patch tree reduce : 1274.00 ns (0.4%)
   gen split merge   : 682.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 728.00 ns  (0.3%)
   LB compute        : 269.66 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.38 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1803.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.64267728165158e-18,-4.892765879949135e-17,7.477905013958398e-18)
    sum a = (7.203612706341288e-17,-2.768098250616191e-17,4.76484086561757e-17)
    sum e = 2.59200098490164
    sum de = 1.0164395367051604e-19
Info: CFL hydro = 0.009543411184917023 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009543411184917023 cfl multiplier : 0.8472108935278584        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9490e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1190.6412228467498 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.700332500548833, dt = 0.009543411184917023 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (0.8%)
   patch tree reduce : 951.00 ns  (0.2%)
   gen split merge   : 360.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 598.00 ns  (0.1%)
   LB compute        : 496.97 us  (97.5%)
   LB move op cnt    : 0
   LB apply          : 2.50 us    (0.5%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.81 us    (72.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.197720710063529e-18,-4.96499813918555e-17,8.255115341304631e-18)
    sum a = (1.192015236517463e-17,-2.4917568008930855e-17,5.598548968172024e-17)
    sum e = 2.5920010125038933
    sum de = 1.179069862577986e-18
Info: CFL hydro = 0.010112308827943728 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010112308827943728 cfl multiplier : 0.898140595685239         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9199e+04 |  512 |      1 | 2.667e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1288.3095251143416 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.70987591173375, dt = 0.010112308827943728 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.81 us    (1.2%)
   patch tree reduce : 1184.00 ns (0.4%)
   gen split merge   : 678.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 906.00 ns  (0.3%)
   LB compute        : 309.43 us  (95.5%)
   LB move op cnt    : 0
   LB apply          : 2.67 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (69.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.335305965751938e-18,-4.9832208671996e-17,8.77471923246831e-18)
    sum a = (-1.7660092138660488e-16,-8.503354270716911e-17,-4.569339901567236e-17)
    sum e = 2.592001028909319
    sum de = -1.0977546996415732e-18
Info: CFL hydro = 0.010492242810979867 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010492242810979867 cfl multiplier : 0.9320937304568261        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9246e+04 |  512 |      1 | 2.660e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1368.4479511045831 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.719988220561694, dt = 0.010492242810979867 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.66 us    (1.6%)
   patch tree reduce : 1026.00 ns (0.4%)
   gen split merge   : 667.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1299.00 ns (0.4%)
   LB compute        : 277.10 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.206066496672875e-17,-5.1129754726972343e-17,7.827722844910844e-18)
    sum a = (1.206066496672875e-17,-1.3828781869618112e-16,-1.4846327292539206e-16)
    sum e = 2.592001036626373
    sum de = -3.049318610115481e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011240334058496063
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1100495522775589e-17,-5.128124487552288e-17,7.338124248870703e-18)
    sum a = (-1.2411946470614055e-17,-5.351188242519456e-17,-3.5547492683793425e-17)
    sum e = 2.592000833569504
    sum de = -5.21772295508649e-19
Info: CFL hydro = 0.005374717269257715 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005374717269257715 cfl multiplier : 0.47736457681894207       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4343e+04 |  512 |      1 | 3.570e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1058.1175533891426 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.730480463372674, dt = 0.005374717269257715 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1574.00 ns (0.5%)
   gen split merge   : 675.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1115.00 ns (0.4%)
   LB compute        : 289.31 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1963.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1337610537898168e-17,-5.132478914527533e-17,7.693064935088146e-18)
    sum a = (7.311339034199449e-17,1.1566528984596759e-16,3.3840118207617564e-18)
    sum e = 2.592000886442705
    sum de = 1.0367683274392636e-18
Info: CFL hydro = 0.007337113692414065 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007337113692414065 cfl multiplier : 0.6515763845459613        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9135e+04 |  512 |      1 | 2.676e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 723.1138813038908 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.735855180641932, dt = 0.007337113692414065 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.4%)
   patch tree reduce : 1431.00 ns (0.5%)
   gen split merge   : 678.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 872.00 ns  (0.3%)
   LB compute        : 272.37 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1903.00 ns (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0629192838396139e-17,-4.982928132613029e-17,7.78454449339161e-18)
    sum a = (-1.0674273964728087e-16,1.9812276819131113e-17,-3.4643674647755195e-17)
    sum e = 2.592000928887399
    sum de = -1.3891340334970526e-18
Info: CFL hydro = 0.008647714829822276 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008647714829822276 cfl multiplier : 0.7677175896973075        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8973e+04 |  512 |      1 | 2.699e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 978.7844495957139 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.743192294334346, dt = 0.008647714829822276 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.2%)
   patch tree reduce : 1160.00 ns (0.3%)
   gen split merge   : 738.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 718.00 ns  (0.2%)
   LB compute        : 331.17 us  (95.5%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2209959605880006e-17,-5.0149982928916464e-17,7.392280147386354e-18)
    sum a = (-2.2329794263642454e-17,7.16614267926019e-18,-1.4276665787071874e-17)
    sum e = 2.592000961830482
    sum de = 8.809142651444724e-20
Info: CFL hydro = 0.009525443837938958 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009525443837938958 cfl multiplier : 0.8451450597982051        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9323e+04 |  512 |      1 | 2.650e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1174.9131418554227 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.751840009164168, dt = 0.009525443837938958 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.5%)
   patch tree reduce : 1365.00 ns (0.5%)
   gen split merge   : 756.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1137.00 ns (0.4%)
   LB compute        : 269.51 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (63.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1867460139591834e-17,-5.0188430072029695e-17,7.272990803358637e-18)
    sum a = (-1.0080608223161924e-16,-3.915617829974849e-17,1.8526879249497473e-16)
    sum e = 2.592000984405166
    sum de = -1.9447876468958736e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010554618202527682
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2119211884042969e-17,-5.043396120651619e-17,8.201691279255407e-18)
    sum a = (6.645075115163656e-17,1.6861512186494565e-18,1.9054094239912e-17)
    sum e = 2.592000834377455
    sum de = -1.599198204416119e-18
Info: CFL hydro = 0.0050561800060659485 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0050561800060659485 cfl multiplier : 0.4483816865994017       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4937e+04 |  512 |      1 | 3.428e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1000.4401502994352 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.761365453002107, dt = 0.0050561800060659485 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.73 us    (1.6%)
   patch tree reduce : 1197.00 ns (0.4%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1297.00 ns (0.4%)
   LB compute        : 273.83 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1956.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1159042440089805e-17,-5.009859714577569e-17,7.515960510212639e-18)
    sum a = (-7.294945897351469e-18,-1.402784138848645e-17,-8.289072553346877e-17)
    sum e = 2.5920008762693314
    sum de = -9.486769009248164e-19
Info: CFL hydro = 0.007129701933856031 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007129701933856031 cfl multiplier : 0.6322544577329344        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9407e+04 |  512 |      1 | 2.638e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 689.9404894385776 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.766421633008172, dt = 0.007129701933856031 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.4%)
   patch tree reduce : 1925.00 ns (0.6%)
   gen split merge   : 717.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 724.00 ns  (0.2%)
   LB compute        : 284.45 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1387375417615253e-17,-5.021422730747127e-17,6.7175269253400005e-18)
    sum a = (-9.585886771856788e-17,-3.624054181750047e-17,2.891339511562618e-17)
    sum e = 2.592000916093571
    sum de = -8.131516293641283e-20
Info: CFL hydro = 0.008513008568114168 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008513008568114168 cfl multiplier : 0.7548363051552895        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9776e+04 |  512 |      1 | 2.589e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 991.3964512441338 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.773551334942028, dt = 0.008513008568114168 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.5%)
   patch tree reduce : 1137.00 ns (0.4%)
   gen split merge   : 625.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 650.00 ns  (0.2%)
   LB compute        : 303.01 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.32 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2461711350331139e-17,-5.055599493729301e-17,7.366665871061384e-18)
    sum a = (-6.338289268437159e-17,6.524468465496369e-17,-7.165849944673619e-17)
    sum e = 2.592000949354535
    sum de = 1.497554250745603e-18
Info: CFL hydro = 0.009431820199833008 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009431820199833008 cfl multiplier : 0.8365575367701931        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0255e+04 |  512 |      1 | 2.528e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1212.395277982168 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.782064343510142, dt = 0.009431820199833008 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.4%)
   patch tree reduce : 2.02 us    (0.6%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 865.00 ns  (0.3%)
   LB compute        : 297.32 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2853975696336395e-17,-4.958631161927629e-17,6.260860970289106e-18)
    sum a = (4.288561693266413e-18,-1.708399047228859e-17,-2.132864197756934e-17)
    sum e = 2.5920009749364454
    sum de = 1.294266343404571e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01056538165386229
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2616860681213816e-17,-5.007225103298429e-17,6.495780476012402e-18)
    sum a = (8.437781723324989e-17,7.08768981005914e-17,-1.5147258447534284e-16)
    sum e = 2.592000835839985
    sum de = -1.009663273127126e-18
Info: CFL hydro = 0.0050214146333467215 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0050214146333467215 cfl multiplier : 0.4455191789233977       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4978e+04 |  512 |      1 | 3.418e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 993.2702086096416 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.791496163709975, dt = 0.0050214146333467215 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.4%)
   patch tree reduce : 1458.00 ns (0.5%)
   gen split merge   : 754.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 883.00 ns  (0.3%)
   LB compute        : 274.39 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1943571132100316e-17,-4.919331543680461e-17,5.135662403156493e-18)
    sum a = (7.42067540228375e-17,-4.947214513051357e-17,8.062495983340856e-17)
    sum e = 2.592000874812186
    sum de = -1.009663273127126e-18
Info: CFL hydro = 0.007103308042096472 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007103308042096472 cfl multiplier : 0.6303461192822651        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0254e+04 |  512 |      1 | 2.528e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 715.1167629736614 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.796517578343321, dt = 0.007103308042096472 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.5%)
   patch tree reduce : 1421.00 ns (0.5%)
   gen split merge   : 792.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 917.00 ns  (0.3%)
   LB compute        : 270.15 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1419576222138072e-17,-4.989661028104164e-17,6.313187277638688e-18)
    sum a = (-2.037725457121331e-17,-9.741036102739464e-17,-2.8644079295980784e-17)
    sum e = 2.5920009150299177
    sum de = 1.3417001884508117e-18
Info: CFL hydro = 0.008490914337415457 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008490914337415457 cfl multiplier : 0.7535640795215102        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0365e+04 |  512 |      1 | 2.514e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1017.1350376284942 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.803620886385418, dt = 0.008490914337415457 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.95 us    (1.2%)
   patch tree reduce : 1360.00 ns (0.4%)
   gen split merge   : 636.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 892.00 ns  (0.3%)
   LB compute        : 316.23 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.47 us    (71.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1946498477966027e-17,-5.0913862969376163e-17,5.655266294320171e-18)
    sum a = (5.016885344655275e-17,6.824228682145161e-17,-6.922880237819618e-17)
    sum e = 2.5920009513356326
    sum de = 1.2874900798265365e-18
Info: CFL hydro = 0.009417304757495163 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009417304757495163 cfl multiplier : 0.8357093863476734        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9582e+04 |  512 |      1 | 2.615e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1169.0960463151316 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.812111800722834, dt = 0.009417304757495163 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1378.00 ns (0.5%)
   gen split merge   : 723.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 912.00 ns  (0.3%)
   LB compute        : 277.29 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1973.00 ns (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0919000079101514e-17,-4.963095364372838e-17,4.853539445348609e-18)
    sum a = (2.4542867738119866e-17,6.845891041551422e-17,1.9578089149874244e-17)
    sum e = 2.592000982514132
    sum de = 9.198777807181702e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010917285371723897
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1156115094224096e-17,-4.95153234820328e-17,5.25861092951635e-18)
    sum a = (2.110030900004389e-17,7.743415283978372e-17,-2.92412578525858e-17)
    sum e = 2.5920008379459496
    sum de = 1.1519648082658485e-19
Info: CFL hydro = 0.005019722415867676 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005019722415867676 cfl multiplier : 0.44523646211589113       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4653e+04 |  512 |      1 | 3.494e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 970.2432291336739 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.821529105480328, dt = 0.005019722415867676 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.4%)
   patch tree reduce : 1515.00 ns (0.5%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 913.00 ns  (0.3%)
   LB compute        : 286.55 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.42 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1935.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1047803297192793e-17,-4.9136964028889675e-17,4.892692696302492e-18)
    sum a = (5.114658696570018e-17,1.1057170803963067e-16,-5.4823333373033024e-17)
    sum e = 2.592000878477424
    sum de = -2.744386749103933e-19
Info: CFL hydro = 0.007106573609896636 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007106573609896636 cfl multiplier : 0.630157641410594         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9833e+04 |  512 |      1 | 2.582e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 699.9869383210715 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.826548827896196, dt = 0.007106573609896636 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1344.00 ns (0.5%)
   gen split merge   : 746.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 842.00 ns  (0.3%)
   LB compute        : 267.79 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.069652179330749e-17,-4.830998882182636e-17,4.31673739722388e-18)
    sum a = (-1.5737411374061593e-17,-1.180422946889248e-16,4.887496657390855e-17)
    sum e = 2.59200092306175
    sum de = 1.020674701441432e-18
Info: CFL hydro = 0.008501495816869686 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008501495816869686 cfl multiplier : 0.7534384276070627        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0533e+04 |  512 |      1 | 2.494e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1025.980455812058 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.833655401506093, dt = 0.008501495816869686 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.88 us    (1.3%)
   patch tree reduce : 1259.00 ns (0.4%)
   gen split merge   : 662.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 920.00 ns  (0.3%)
   LB compute        : 286.80 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.58 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1024384530267106e-17,-5.0161535081888476e-17,5.144078522520412e-18)
    sum a = (4.3500359564463406e-17,-3.877562333720608e-17,-2.7356047115068005e-17)
    sum e = 2.5920009652671205
    sum de = 1.4363561203064798e-18
Info: CFL hydro = 0.00943700639099522 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00943700639099522 cfl multiplier : 0.8356256184047085         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0064e+04 |  512 |      1 | 2.552e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1199.35441179473 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 6.842156897322963, dt = 0.00943700639099522 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1510.00 ns (0.5%)
   gen split merge   : 803.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 832.00 ns  (0.3%)
   LB compute        : 290.61 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0418423936064958e-17,-5.016299875482133e-17,4.560438940544309e-18)
    sum a = (3.416798094457718e-17,6.670103922315484e-17,-5.890990820156538e-17)
    sum e = 2.592001002803936
    sum de = 1.7338764430295528e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010586188433662928
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0377441093945006e-17,-4.948970920570783e-17,4.44956571588051e-18)
    sum a = (-1.1416648876272362e-16,4.646136990762995e-17,-2.4434555941088565e-17)
    sum e = 2.592000840118
    sum de = 5.090668012998345e-19
Info: CFL hydro = 0.005029463875700643 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005029463875700643 cfl multiplier : 0.4452085394682362        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4666e+04 |  512 |      1 | 3.491e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 973.1602823272839 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.851593903713958, dt = 0.005029463875700643 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.4%)
   patch tree reduce : 1080.00 ns (0.4%)
   gen split merge   : 648.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 988.00 ns  (0.3%)
   LB compute        : 284.31 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.68 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1691819387649182e-17,-4.9382861081609385e-17,4.441149596516592e-18)
    sum a = (-7.119305145408816e-17,-5.005541879425646e-17,-2.9059762408911726e-17)
    sum e = 2.5920008857283476
    sum de = 1.8262030342802715e-18
Info: CFL hydro = 0.007116305119806511 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007116305119806511 cfl multiplier : 0.6301390263121575        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0196e+04 |  512 |      1 | 2.535e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 714.2076098168775 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.856623367589659, dt = 0.007116305119806511 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 1921.00 ns (0.6%)
   gen split merge   : 627.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 289.10 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.67 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2163122072028632e-17,-5.006054164952145e-17,4.298441485563187e-18)
    sum a = (-2.7493632370756417e-16,4.910915424316542e-17,-1.8802342495460866e-17)
    sum e = 2.592000936288191
    sum de = 2.0328790734103208e-19
Info: CFL hydro = 0.008505375265904442 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008505375265904442 cfl multiplier : 0.7534260175414383        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9834e+04 |  512 |      1 | 2.581e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 992.4080195485428 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.863739672709466, dt = 0.008505375265904442 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.77 us    (1.3%)
   patch tree reduce : 1344.00 ns (0.5%)
   gen split merge   : 670.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 653.00 ns  (0.2%)
   LB compute        : 274.61 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.46 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5128523433993735e-17,-4.925698520938382e-17,4.157562965775852e-18)
    sum a = (-4.9015479175462675e-17,-9.978736587035186e-17,6.211827927038448e-17)
    sum e = 2.592000983475441
    sum de = 1.7618285302889447e-19
Info: CFL hydro = 0.00943000981197683 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00943000981197683 cfl multiplier : 0.8356173450276255         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0008e+04 |  512 |      1 | 2.559e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1196.56618699795 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 6.87224504797537, dt = 0.00943000981197683 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1377.00 ns (0.5%)
   gen split merge   : 664.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 786.00 ns  (0.3%)
   LB compute        : 276.34 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1979.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4865062306079757e-17,-5.082311524753913e-17,5.0754688537928135e-18)
    sum a = (-2.5526455948998716e-17,-1.348628240332994e-16,-8.429292420314427e-18)
    sum e = 2.592001023553843
    sum de = -5.21772295508649e-19
Info: CFL hydro = 0.010046030322708994 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010046030322708994 cfl multiplier : 0.8904115633517504        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9506e+04 |  512 |      1 | 2.625e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1293.3301266712672 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.881675057787347, dt = 0.010046030322708994 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.4%)
   patch tree reduce : 1119.00 ns (0.4%)
   gen split merge   : 700.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 856.00 ns  (0.3%)
   LB compute        : 282.22 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4835788847422647e-17,-5.2272883287532434e-17,4.707355111179673e-18)
    sum a = (3.37698619068405e-17,1.6056492073424078e-16,-2.2880135286396098e-17)
    sum e = 2.592001055635195
    sum de = -5.014435047745458e-19
Info: CFL hydro = 0.010457346103280805 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010457346103280805 cfl multiplier : 0.9269410422345002        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0141e+04 |  512 |      1 | 2.542e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1422.6865437007723 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.891721088110056, dt = 0.010457346103280805 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.3%)
   patch tree reduce : 1271.00 ns (0.4%)
   gen split merge   : 653.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 903.00 ns  (0.3%)
   LB compute        : 305.52 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.72 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4174208681771995e-17,-4.925259419058525e-17,4.3802242106864844e-18)
    sum a = (3.793840241961277e-17,-3.081909727420395e-17,9.701132719407492e-18)
    sum e = 2.5920010796845423
    sum de = 1.0842021724855044e-19
Info: CFL hydro = 0.010733173045953993 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010733173045953993 cfl multiplier : 0.9512940281563335        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0030e+04 |  512 |      1 | 2.556e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1472.7411913473236 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.9021784342133365, dt = 0.010733173045953993 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.86 us    (1.3%)
   patch tree reduce : 1060.00 ns (0.4%)
   gen split merge   : 604.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 806.00 ns  (0.3%)
   LB compute        : 276.84 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.70 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3802435756826713e-17,-5.0545749226763025e-17,4.6100208611447865e-18)
    sum a = (8.262140971382337e-17,-1.1697674079380605e-16,1.150190782461119e-16)
    sum e = 2.592001095908991
    sum de = -8.402566836762659e-19
Info: CFL hydro = 0.010919578773977135 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010919578773977135 cfl multiplier : 0.9675293521042224        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0142e+04 |  512 |      1 | 2.542e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1520.0609325931177 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.91291160725929, dt = 0.010919578773977135 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.6%)
   patch tree reduce : 904.00 ns  (0.3%)
   gen split merge   : 637.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 822.00 ns  (0.3%)
   LB compute        : 273.13 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.55 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2792501433156466e-17,-5.227800614279743e-17,6.4549805930090575e-18)
    sum a = (5.61113655539458e-17,9.654386665114423e-17,3.313023683518268e-17)
    sum e = 2.5920011046648264
    sum de = -2.303929616531697e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010349720591312462
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2815920200082154e-17,-5.1090235557785245e-17,6.0129513672867175e-18)
    sum a = (1.259929660601955e-17,6.832425250569151e-17,1.5440871237865085e-16)
    sum e = 2.5920008483915655
    sum de = 1.1519648082658485e-19
Info: CFL hydro = 0.005524114540893901 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005524114540893901 cfl multiplier : 0.48917645070140753       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5012e+04 |  512 |      1 | 3.410e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1152.633226864418 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.923831186033268, dt = 0.005524114540893901 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.4%)
   patch tree reduce : 1458.00 ns (0.5%)
   gen split merge   : 663.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 954.00 ns  (0.3%)
   LB compute        : 275.46 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.73 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3020834410681914e-17,-5.08619025802598e-17,7.548161314735458e-18)
    sum a = (2.3896509770970907e-16,1.789193793122479e-17,-1.2793965106089323e-17)
    sum e = 2.592000913300009
    sum de = 9.75781955236954e-19
Info: CFL hydro = 0.007449185168593894 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007449185168593894 cfl multiplier : 0.6594509671342718        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9967e+04 |  512 |      1 | 2.564e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 775.5460177915157 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.929355300574161, dt = 0.007449185168593894 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.3%)
   patch tree reduce : 1130.00 ns (0.4%)
   gen split merge   : 768.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 307.58 us  (95.5%)
   LB move op cnt    : 0
   LB apply          : 2.47 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.36 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.062626549253043e-17,-5.0924840516372585e-17,7.012822939543584e-18)
    sum a = (-2.784491387464172e-17,-9.957659696802068e-17,-3.364984072634636e-17)
    sum e = 2.592000964457204
    sum de = -3.4558944247975454e-19
Info: CFL hydro = 0.008730903054527872 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008730903054527872 cfl multiplier : 0.7729673114228479        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9826e+04 |  512 |      1 | 2.582e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1038.4208811154904 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.936804485742755, dt = 0.008730903054527872 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.3%)
   patch tree reduce : 1513.00 ns (0.5%)
   gen split merge   : 640.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1040.00 ns (0.3%)
   LB compute        : 294.90 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1908442981711786e-17,-5.230435225558883e-17,6.692278567248244e-18)
    sum a = (-1.401144825163847e-16,2.224782857940255e-18,-3.1533369665437405e-17)
    sum e = 2.592001003621948
    sum de = 1.0028870095490916e-18
Info: CFL hydro = 0.00957361034947831 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00957361034947831 cfl multiplier : 0.8486448742818986         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0147e+04 |  512 |      1 | 2.541e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1236.8205837592418 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.945535388797283, dt = 0.00957361034947831 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.5%)
   patch tree reduce : 1583.00 ns (0.6%)
   gen split merge   : 651.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 796.00 ns  (0.3%)
   LB compute        : 266.21 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.72 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.378779902749816e-17,-5.1731873179725746e-17,6.365147666755056e-18)
    sum a = (-2.6229018956769322e-17,-2.9121236672091655e-17,-9.252462077752322e-17)
    sum e = 2.592001027670727
    sum de = 2.371692252312041e-19
Info: CFL hydro = 0.010130705402483607 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010130705402483607 cfl multiplier : 0.899096582854599         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0389e+04 |  512 |      1 | 2.511e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1372.504488092897 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.955108999146761, dt = 0.010130705402483607 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.6%)
   patch tree reduce : 1236.00 ns (0.4%)
   gen split merge   : 647.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 708.00 ns  (0.3%)
   LB compute        : 265.99 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.61 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1905.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3538974628912737e-17,-5.2298040166065885e-17,5.190916056371786e-18)
    sum a = (1.132765756195475e-16,-6.779733024986356e-17,-7.766834050904059e-17)
    sum e = 2.592001038405648
    sum de = -1.0842021724855044e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01047401342178964
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2579537021426002e-17,-5.246974729700149e-17,5.1737178994107345e-18)
    sum a = (-5.4565726936850464e-17,-6.95888659196786e-17,4.805530973150951e-17)
    sum e = 2.592000846301138
    sum de = 5.285485590866834e-19
Info: CFL hydro = 0.005250098683485315 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005250098683485315 cfl multiplier : 0.46636552761819966       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4991e+04 |  512 |      1 | 3.415e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1067.803070541066 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.965239704549244, dt = 0.005250098683485315 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.3%)
   patch tree reduce : 1572.00 ns (0.5%)
   gen split merge   : 659.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 636.00 ns  (0.2%)
   LB compute        : 283.89 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.53 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3930507138451566e-17,-5.2826334615268395e-17,6.1338873433638974e-18)
    sum a = (-1.3479842242425378e-16,-9.989275032151745e-17,-6.686643426456751e-17)
    sum e = 2.592000897712893
    sum de = -5.149960319306146e-19
Info: CFL hydro = 0.007249243804529243 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007249243804529243 cfl multiplier : 0.6442436850787998        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0418e+04 |  512 |      1 | 2.508e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 753.7406873119327 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 6.97048980323273, dt = 0.007249243804529243 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1328.00 ns (0.4%)
   gen split merge   : 776.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 835.00 ns  (0.3%)
   LB compute        : 282.25 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5194388715972228e-17,-5.356704459885154e-17,5.331428657925907e-18)
    sum a = (1.2144972527661223e-16,-8.21179062249211e-17,-5.0648938168529333e-17)
    sum e = 2.592000938408144
    sum de = -1.463672932855431e-18
Info: CFL hydro = 0.0085792850097717 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0085792850097717 cfl multiplier : 0.7628291233858665          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0121e+04 |  512 |      1 | 2.545e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1025.61654910625 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 6.977739047037259, dt = 0.0085792850097717 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.4%)
   patch tree reduce : 1355.00 ns (0.5%)
   gen split merge   : 656.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 859.00 ns  (0.3%)
   LB compute        : 274.48 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3299664104390873e-17,-5.43342836543427e-17,4.927820846691022e-18)
    sum a = (-1.0983401688147154e-16,3.65449857875344e-17,9.451814331207231e-17)
    sum e = 2.59200096733596
    sum de = 6.776263578034403e-20
Info: CFL hydro = 0.00946449385534025 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00946449385534025 cfl multiplier : 0.8418860822572443         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0434e+04 |  512 |      1 | 2.506e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1232.6193898304143 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.986318332047031, dt = 0.00946449385534025 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.4%)
   patch tree reduce : 1072.00 ns (0.4%)
   gen split merge   : 618.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 832.00 ns  (0.3%)
   LB compute        : 275.80 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.519731606183794e-17,-5.342552572215609e-17,6.4064964271082215e-18)
    sum a = (8.276192231537748e-17,7.305484342468027e-17,6.263934683448102e-17)
    sum e = 2.592000983385775
    sum de = 2.846030702774449e-19
Info: CFL hydro = 0.01005471969857613 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01005471969857613 cfl multiplier : 0.8945907215048295         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0556e+04 |  512 |      1 | 2.491e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1367.9441859533956 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 6.995782825902371, dt = 0.004217174097629339 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.5%)
   patch tree reduce : 1760.00 ns (0.6%)
   gen split merge   : 584.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 860.00 ns  (0.3%)
   LB compute        : 257.68 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.42 us    (1.3%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.31 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3978808345235793e-17,-5.296446874830662e-17,6.525053934669511e-18)
    sum a = (5.2106756409653346e-18,4.405070058721705e-17,8.827118723464533e-17)
    sum e = 2.5920008706032465
    sum de = -1.3010426069826053e-18
Info: CFL hydro = 0.010450446908777637 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010450446908777637 cfl multiplier : 0.9297271476698864        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0077e+04 |  512 |      1 | 2.550e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 595.3252028073861 (tsim/hr)                             [sph::Model][rank=0]
Info: iteration since start : 935                                                     [SPH][rank=0]
Info: time since start : 1765.4668547330002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14983661110633803 max=0.15022148426212542 delta=0.0003848731557873908
Number of particle pairs: 130816
Distance min=0.146775 max=1.988630 mean=0.806128
---------------- t = 7, dt = 0.010450446908777637 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 8.48 us    (1.5%)
   patch tree reduce : 1600.00 ns (0.3%)
   gen split merge   : 435.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 827.00 ns  (0.1%)
   LB compute        : 546.38 us  (96.1%)
   LB move op cnt    : 0
   LB apply          : 4.29 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (81.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3996006502196844e-17,-5.258318194929779e-17,7.455218083499137e-18)
    sum a = (-1.060518860229731e-16,1.9297063946766003e-17,1.5034848366290987e-17)
    sum e = 2.5920009990671917
    sum de = 8.131516293641283e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.012235837717627459
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.455805690841333e-17,-5.2695152928661225e-17,7.097350051415985e-18)
    sum a = (1.1318290055184475e-16,-1.9168260728674723e-17,-8.322444296215981e-17)
    sum e = 2.5920008458733177
    sum de = 1.145188544687814e-18
Info: CFL hydro = 0.005357856090402247 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005357856090402247 cfl multiplier : 0.4765757158899621        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.1163e+04 |  512 |      1 | 4.586e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 820.2720202134877 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.010450446908778, dt = 0.005357856090402247 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.4%)
   patch tree reduce : 1556.00 ns (0.5%)
   gen split merge   : 739.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1016.00 ns (0.3%)
   LB compute        : 313.78 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.32 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2796252095046908e-17,-5.301423362802371e-17,6.093270419477159e-18)
    sum a = (4.129899547344884e-17,7.34412530789541e-17,8.835900761061665e-17)
    sum e = 2.592000885496502
    sum de = 2.846030702774449e-19
Info: CFL hydro = 0.0073153159865389575 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0073153159865389575 cfl multiplier : 0.6510504772599748       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9778e+04 |  512 |      1 | 2.589e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 745.0800702318126 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.01580830299918, dt = 0.0073153159865389575 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.4%)
   patch tree reduce : 1391.00 ns (0.4%)
   gen split merge   : 700.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1007.00 ns (0.3%)
   LB compute        : 300.79 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2799225180691771e-17,-5.2209213514953225e-17,7.271527130425781e-18)
    sum a = (-5.695444116327053e-17,1.999962695453661e-17,2.204291436880279e-17)
    sum e = 2.592000915925197
    sum de = -4.743384504624082e-20
Info: CFL hydro = 0.008611992482616312 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008611992482616312 cfl multiplier : 0.7673669848399832        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0074e+04 |  512 |      1 | 2.551e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1032.5371416996325 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.02312361898572, dt = 0.008611992482616312 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.2%)
   patch tree reduce : 1269.00 ns (0.4%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 894.00 ns  (0.3%)
   LB compute        : 319.73 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3481113808285796e-17,-5.220262698675537e-17,7.224689596574407e-18)
    sum a = (1.1385033540922685e-16,-5.782093553952094e-17,7.025630077706068e-18)
    sum e = 2.5920009393424257
    sum de = 4.743384504624082e-20
Info: CFL hydro = 0.009471260899249975 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009471260899249975 cfl multiplier : 0.8449113232266555        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9278e+04 |  512 |      1 | 2.656e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1167.3615812733822 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.031735611468336, dt = 0.009471260899249975 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.92 us    (1.3%)
   patch tree reduce : 1482.00 ns (0.5%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 877.00 ns  (0.3%)
   LB compute        : 294.85 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.172370001371794e-17,-5.289201693813028e-17,7.105400252546689e-18)
    sum a = (-5.0663574897857887e-17,-8.290243491693161e-18,1.2629155533849801e-16)
    sum e = 2.5920009566723796
    sum de = -7.115076756936123e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010535898788411763
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2527164974297269e-17,-5.2835665530215345e-17,7.759662053533068e-18)
    sum a = (3.7696896385691625e-17,-1.1869802016284404e-16,-8.491644887254068e-17)
    sum e = 2.59200084784182
    sum de = 6.166399856011306e-19
Info: CFL hydro = 0.0050213344883886886 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0050213344883886886 cfl multiplier : 0.44830377440888514      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4407e+04 |  512 |      1 | 3.554e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 959.4399419060624 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.041206872367586, dt = 0.0050213344883886886 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.81 us    (1.3%)
   patch tree reduce : 1198.00 ns (0.4%)
   gen split merge   : 872.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 737.00 ns  (0.3%)
   LB compute        : 270.92 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1915075249688787e-17,-5.397074388964473e-17,6.320871560536178e-18)
    sum a = (1.0254199832998579e-16,1.150271284472426e-16,1.6428264998369357e-17)
    sum e = 2.5920008780092405
    sum de = 1.1926223897340549e-18
Info: CFL hydro = 0.007078222560401908 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007078222560401908 cfl multiplier : 0.63220251627259          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0533e+04 |  512 |      1 | 2.494e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 724.9332439491671 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.046228206855974, dt = 0.007078222560401908 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.65 us    (1.2%)
   patch tree reduce : 882.00 ns  (0.3%)
   gen split merge   : 583.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 711.00 ns  (0.2%)
   LB compute        : 292.40 us  (95.5%)
   LB move op cnt    : 0
   LB apply          : 2.72 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0999685049525171e-17,-5.261904193615274e-17,6.641415932831518e-18)
    sum a = (1.3118022293423514e-16,-2.845380181470958e-18,2.2429324023076624e-17)
    sum e = 2.592000908863703
    sum de = 1.1316360175317453e-18
Info: CFL hydro = 0.008447422996122564 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008447422996122564 cfl multiplier : 0.75480167751506          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9903e+04 |  512 |      1 | 2.573e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 990.5274603351089 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.053306429416376, dt = 0.008447422996122564 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.57 us    (1.2%)
   patch tree reduce : 1111.00 ns (0.4%)
   gen split merge   : 524.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 623.00 ns  (0.2%)
   LB compute        : 294.28 us  (95.8%)
   LB move op cnt    : 0
   LB apply          : 2.37 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (70.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.737324319661301e-18,-5.306253483480794e-17,6.90999991601049e-18)
    sum a = (-3.159777127448304e-17,1.0872162545250142e-17,-4.604129577590044e-17)
    sum e = 2.5920009375289164
    sum de = -4.54009659728305e-19
Info: CFL hydro = 0.00935998155502763 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00935998155502763 cfl multiplier : 0.8365344516767067         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0324e+04 |  512 |      1 | 2.519e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1207.1639762107905 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.061753852412499, dt = 0.00935998155502763 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.27 us    (1.2%)
   patch tree reduce : 861.00 ns  (0.3%)
   gen split merge   : 523.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 677.00 ns  (0.2%)
   LB compute        : 265.52 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.37 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0790745738360058e-17,-5.2900067139260984e-17,6.1796271225156296e-18)
    sum a = (1.0198872996136643e-16,1.0090853933691912e-16,4.427317887301108e-17)
    sum e = 2.5920009640468225
    sum de = 7.657177843178875e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011230160790015755
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0082419518416332e-17,-5.2474138315800055e-17,6.5601820850580415e-18)
    sum a = (-8.10406429463395e-17,1.3083186877621556e-16,1.583108644176434e-17)
    sum e = 2.5920008504655616
    sum de = -6.098637220230962e-20
Info: CFL hydro = 0.004985952390651943 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.004985952390651943 cfl multiplier : 0.44551148389223555       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5115e+04 |  512 |      1 | 3.387e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 994.7741954102625 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.071113833967527, dt = 0.004985952390651943 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.4%)
   patch tree reduce : 1072.00 ns (0.3%)
   gen split merge   : 566.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 885.00 ns  (0.3%)
   LB compute        : 292.75 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1442812029947153e-17,-5.169985533431953e-17,6.549936374528054e-18)
    sum a = (-3.9741647472890664e-17,-7.960185245334261e-17,4.093600458610069e-17)
    sum e = 2.5920008821312894
    sum de = -3.8285889215894375e-19
Info: CFL hydro = 0.007055431386733184 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007055431386733184 cfl multiplier : 0.6303409892614904        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9735e+04 |  512 |      1 | 2.594e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 691.8592633421209 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.076099786358179, dt = 0.007055431386733184 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.96 us    (1.4%)
   patch tree reduce : 835.00 ns  (0.3%)
   gen split merge   : 584.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 753.00 ns  (0.3%)
   LB compute        : 272.40 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.39 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.156978565687236e-17,-5.268783456399695e-17,6.908536243077634e-18)
    sum a = (-2.2563981932899323e-17,-1.0882993724953272e-16,2.709551333301974e-17)
    sum e = 2.5920009193173077
    sum de = -1.0638733817514012e-18
Info: CFL hydro = 0.008437713882027669 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008437713882027669 cfl multiplier : 0.7535606595076603        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0031e+04 |  512 |      1 | 2.556e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 993.698043583012 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 7.0831552177449115, dt = 0.008437713882027669 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.53 us    (1.1%)
   patch tree reduce : 768.00 ns  (0.2%)
   gen split merge   : 589.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 595.00 ns  (0.2%)
   LB compute        : 299.02 us  (96.0%)
   LB move op cnt    : 0
   LB apply          : 2.25 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (70.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.177122364425659e-17,-5.3675813793674365e-17,6.92902766413761e-18)
    sum a = (-2.353586076031533e-17,1.4183576188542268e-16,-3.05614908380214e-17)
    sum e = 2.5920009570567197
    sum de = -1.2569968937253817e-18
Info: CFL hydro = 0.009363953971055832 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009363953971055832 cfl multiplier : 0.8357071063384401        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8756e+04 |  512 |      1 | 2.730e-02 | 0.1% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1112.7513261571369 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.0915929316269395, dt = 0.009363953971055832 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.03 us    (1.1%)
   patch tree reduce : 757.00 ns  (0.3%)
   gen split merge   : 575.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 497.00 ns  (0.2%)
   LB compute        : 255.54 us  (91.1%)
   LB move op cnt    : 0
   LB apply          : 2.37 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1943205213867104e-17,-5.133686444697138e-17,6.494316803079547e-18)
    sum a = (7.116963268716247e-17,-3.454268121538817e-19,1.6346299314129453e-17)
    sum e = 2.5920009939422495
    sum de = -4.0318768289304696e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011510173869156539
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1457265800159099e-17,-5.206284622166768e-17,6.782660370852067e-18)
    sum a = (2.0636617414915293e-16,1.8688176006698142e-17,1.5468095554416195e-17)
    sum e = 2.592000853402085
    sum de = -1.1418004128987969e-18
Info: CFL hydro = 0.0049948763985413905 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0049948763985413905 cfl multiplier : 0.4452357021128133       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5300e+04 |  512 |      1 | 3.346e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1007.3768488359813 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.100956885597995, dt = 0.0049948763985413905 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.70 us    (1.4%)
   patch tree reduce : 1024.00 ns (0.4%)
   gen split merge   : 641.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 701.00 ns  (0.3%)
   LB compute        : 257.59 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.43 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.736352349354326e-18,-5.1770111635096594e-17,6.864626055091971e-18)
    sum a = (4.657992741519123e-17,1.3635577042481196e-16,7.113450453677395e-18)
    sum e = 2.5920008927299794
    sum de = -4.955142741437657e-19
Info: CFL hydro = 0.0070741090521256505 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0070741090521256505 cfl multiplier : 0.6301571347418755       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0168e+04 |  512 |      1 | 2.539e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 708.2954643920481 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.105951761996536, dt = 0.0070741090521256505 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.81 us    (1.4%)
   patch tree reduce : 703.00 ns  (0.3%)
   gen split merge   : 671.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 958.00 ns  (0.4%)
   LB compute        : 256.45 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.42 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1967.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.858569039247755e-18,-5.0565508811356575e-17,6.9158546077419116e-18)
    sum a = (-7.430774745520451e-17,-1.0577671551159628e-16,-8.909084407704437e-17)
    sum e = 2.592000940082837
    sum de = 8.428507220772322e-19
Info: CFL hydro = 0.008467350527169095 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008467350527169095 cfl multiplier : 0.753438089827917         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0652e+04 |  512 |      1 | 2.479e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1027.206681647367 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.113025871048662, dt = 0.008467350527169095 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.3%)
   patch tree reduce : 1026.00 ns (0.3%)
   gen split merge   : 504.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 696.00 ns  (0.2%)
   LB compute        : 280.93 us  (95.5%)
   LB move op cnt    : 0
   LB apply          : 2.56 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0911681714437238e-17,-5.231532980258524e-17,5.8825015171459774e-18)
    sum a = (-9.957659696802068e-17,4.42263413391597e-17,-1.3692953021449128e-16)
    sum e = 2.592000987810858
    sum de = -1.3484764520288461e-18
Info: CFL hydro = 0.009405448677754566 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009405448677754566 cfl multiplier : 0.8356253932186114        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0129e+04 |  512 |      1 | 2.544e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1198.3854985132155 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.1214932215758315, dt = 0.009405448677754566 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.4%)
   patch tree reduce : 1284.00 ns (0.5%)
   gen split merge   : 702.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 826.00 ns  (0.3%)
   LB compute        : 267.35 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.41 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1879.00 ns (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1816231586941895e-17,-5.135881954096422e-17,4.373454723372028e-18)
    sum a = (9.702395137312081e-17,1.0937735092642064e-16,4.186690057139675e-17)
    sum e = 2.5920010324769795
    sum de = -4.506215279392878e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011399165951685077
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0962910267087178e-17,-5.096435968555968e-17,5.266295212413841e-18)
    sum a = (-6.23641763231042e-17,9.282028270996001e-17,5.590645134334604e-17)
    sum e = 2.5920008557221452
    sum de = 1.0418505251227894e-18
Info: CFL hydro = 0.005020194980343842 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005020194980343842 cfl multiplier : 0.44520846440620376       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5014e+04 |  512 |      1 | 3.410e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 992.8879629885058 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.130898670253586, dt = 0.005020194980343842 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.4%)
   patch tree reduce : 1185.00 ns (0.4%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 303.56 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (69.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2044564564467341e-17,-5.062039654633865e-17,5.5648844907163484e-18)
    sum a = (5.878110498347411e-18,7.582996730537417e-17,-1.3500919132658496e-17)
    sum e = 2.592000905420525
    sum de = -7.623296525288703e-19
Info: CFL hydro = 0.007110842487592581 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007110842487592581 cfl multiplier : 0.6301389762708025        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0069e+04 |  512 |      1 | 2.551e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 708.4112346725228 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.13591886523393, dt = 0.007110842487592581 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.4%)
   patch tree reduce : 1632.00 ns (0.6%)
   gen split merge   : 685.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 900.00 ns  (0.3%)
   LB compute        : 271.56 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1892342579450377e-17,-5.011396571157067e-17,5.238485426689587e-18)
    sum a = (9.97171095695748e-17,1.5018455229443007e-16,-5.892747227675965e-17)
    sum e = 2.5920009622598115
    sum de = -4.777265822514254e-19
Info: CFL hydro = 0.008512523983403094 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008512523983403094 cfl multiplier : 0.753425984180535         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0051e+04 |  512 |      1 | 2.554e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1002.4964653941904 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.143029707721523, dt = 0.008512523983403094 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.76 us    (1.4%)
   patch tree reduce : 1243.00 ns (0.4%)
   gen split merge   : 759.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1296.00 ns (0.4%)
   LB compute        : 310.83 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.72 us    (70.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.064529324065755e-17,-4.858442749673675e-17,4.5871509715689204e-18)
    sum a = (-1.531587356939923e-17,1.1702357832765743e-16,-6.755143319714385e-17)
    sum e = 2.592001016140573
    sum de = 5.353248226647178e-19
Info: CFL hydro = 0.009443810970701499 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009443810970701499 cfl multiplier : 0.8356173227870233        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0633e+04 |  512 |      1 | 2.481e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1234.9752193722532 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.1515422317049255, dt = 0.009443810970701499 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.65 us    (1.6%)
   patch tree reduce : 1477.00 ns (0.5%)
   gen split merge   : 916.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 961.00 ns  (0.3%)
   LB compute        : 275.37 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1381520725883831e-17,-4.7597911939992185e-17,3.9416712081796756e-18)
    sum a = (-1.5742095127446731e-16,8.620448105345346e-17,2.919734766460014e-17)
    sum e = 2.592001061258136
    sum de = 1.6263032587282567e-19
Info: CFL hydro = 0.010060213545653549 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010060213545653549 cfl multiplier : 0.8904115485246823        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0170e+04 |  512 |      1 | 2.538e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1339.2918812756834 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.160986042675627, dt = 0.010060213545653549 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.5%)
   patch tree reduce : 1233.00 ns (0.4%)
   gen split merge   : 1039.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 280.93 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1978.00 ns (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3524337899584182e-17,-4.678410978932457e-17,4.717417862593054e-18)
    sum a = (-3.391037450839462e-17,7.049048844631756e-18,-2.540936211437028e-17)
    sum e = 2.5920010954196613
    sum de = 2.642742795433417e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010148300652735727
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2868612425664948e-17,-4.7059646218934605e-17,4.490548558000462e-18)
    sum a = (-2.3137741722578652e-17,4.3137368677115264e-17,-2.4273551918474466e-17)
    sum e = 2.5920008584342713
    sum de = 1.7753810574450135e-18
Info: CFL hydro = 0.005236038713112092 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005236038713112092 cfl multiplier : 0.46347051617489415       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4712e+04 |  512 |      1 | 3.480e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1040.6867157922889 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.17104625622128, dt = 0.005236038713112092 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.79 us    (1.7%)
   patch tree reduce : 1377.00 ns (0.5%)
   gen split merge   : 946.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 963.00 ns  (0.3%)
   LB compute        : 266.11 us  (93.7%)
   LB move op cnt    : 0
   LB apply          : 3.46 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2848121004604973e-17,-4.6813943560276285e-17,4.373454723372028e-18)
    sum a = (-1.9840379339441938e-16,-8.896789555068451e-17,-5.6087946787020115e-18)
    sum e = 2.5920009219583413
    sum de = -5.692061405548898e-19
Info: CFL hydro = 0.007256246686629903 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007256246686629903 cfl multiplier : 0.6423136774499295        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0010e+04 |  512 |      1 | 2.559e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 736.69455034312 (tsim/hr)                               [sph::Model][rank=0]
---------------- t = 7.176282294934392, dt = 0.007256246686629903 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.75 us    (1.4%)
   patch tree reduce : 1057.00 ns (0.4%)
   gen split merge   : 756.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 882.00 ns  (0.3%)
   LB compute        : 260.12 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.29 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4827006809825515e-17,-4.781234002465551e-17,4.3602816669763285e-18)
    sum a = (2.33438268715247e-16,3.583071339630095e-17,-8.695388159507545e-17)
    sum e = 2.5920009812975047
    sum de = 1.5585406229479126e-19
Info: CFL hydro = 0.008603383751725395 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008603383751725395 cfl multiplier : 0.7615424516332864        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0802e+04 |  512 |      1 | 2.461e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1061.3199682539398 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.183538541621022, dt = 0.008603383751725395 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.78 us    (1.4%)
   patch tree reduce : 1002.00 ns (0.4%)
   gen split merge   : 794.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 787.00 ns  (0.3%)
   LB compute        : 259.38 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.38 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1346392575495301e-17,-4.6871930165295894e-17,3.3532746891717924e-18)
    sum a = (1.4554763644314406e-16,1.1250375631099985e-16,-7.394475656785637e-17)
    sum e = 2.592001029927302
    sum de = 1.7414997395548415e-18
Info: CFL hydro = 0.00950259339236574 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00950259339236574 cfl multiplier : 0.8410283010888575         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0307e+04 |  512 |      1 | 2.521e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1228.405716495657 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.192141925372748, dt = 0.00950259339236574 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.99 us    (1.4%)
   patch tree reduce : 1114.00 ns (0.4%)
   gen split merge   : 749.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 983.00 ns  (0.3%)
   LB compute        : 277.42 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.30 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1871.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0277911334510836e-17,-4.559121634904739e-17,2.6975492152525595e-18)
    sum a = (-1.6685871434551913e-16,1.1709383462843449e-18,-8.328884457120544e-17)
    sum e = 2.592001062886376
    sum de = -1.1926223897340549e-18
Info: CFL hydro = 0.010103992924071452 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010103992924071452 cfl multiplier : 0.8940188673925716        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0325e+04 |  512 |      1 | 2.519e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1357.9902550108536 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.2016445187651135, dt = 0.010103992924071452 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.3%)
   patch tree reduce : 993.00 ns  (0.3%)
   gen split merge   : 698.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 927.00 ns  (0.3%)
   LB compute        : 296.27 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.63 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3533119937181315e-17,-4.649430254861919e-17,1.8383732036664213e-18)
    sum a = (5.1474449702659794e-17,4.5362151535055517e-17,1.3026689102413336e-17)
    sum e = 2.592001080083203
    sum de = -1.5178830414797062e-18
Info: CFL hydro = 0.010491106251120359 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010491106251120359 cfl multiplier : 0.9293459115950476        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9885e+04 |  512 |      1 | 2.575e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1412.6786477594735 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.211748511689185, dt = 0.010491106251120359 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.63 us    (1.3%)
   patch tree reduce : 913.00 ns  (0.3%)
   gen split merge   : 558.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 799.00 ns  (0.3%)
   LB compute        : 275.32 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.18 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1990.00 ns (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1832331989203304e-17,-4.565927714042517e-17,2.3916415722857743e-18)
    sum a = (-8.615764351960209e-17,2.5643549783627152e-17,-1.0381539378157001e-16)
    sum e = 2.5920010827426294
    sum de = -4.2012834183813297e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010679027396102386
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2637352102273791e-17,-4.53987433583769e-17,1.797390361546469e-18)
    sum a = (-1.962492668372562e-17,2.4378936369640058e-17,3.268381659066177e-17)
    sum e = 2.5920008539950135
    sum de = 6.369687763352339e-19
Info: CFL hydro = 0.005367396025220343 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005367396025220343 cfl multiplier : 0.4764486371983492        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5168e+04 |  512 |      1 | 3.375e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1118.9022459446896 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.222239617940305, dt = 0.005367396025220343 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.3%)
   patch tree reduce : 1193.00 ns (0.4%)
   gen split merge   : 753.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 880.00 ns  (0.3%)
   LB compute        : 291.51 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.243243789167403e-17,-4.5325559711734133e-17,2.6873035047225714e-18)
    sum a = (2.5081499377410664e-17,5.632213445627699e-17,1.21654639487212e-16)
    sum e = 2.592000913912105
    sum de = -4.2012834183813297e-19
Info: CFL hydro = 0.007325749218473743 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007325749218473743 cfl multiplier : 0.6509657581322328        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9412e+04 |  512 |      1 | 2.638e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 732.5948460384833 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.2276070139655255, dt = 0.007325749218473743 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1071.00 ns (0.4%)
   gen split merge   : 980.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 913.00 ns  (0.3%)
   LB compute        : 276.40 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2075301696057306e-17,-4.523042097109853e-17,3.846532467544073e-18)
    sum a = (-5.800828567492645e-17,-2.09129588646384e-17,2.5488400452744475e-17)
    sum e = 2.592000957302944
    sum de = -9.0801931945661e-19
Info: CFL hydro = 0.008623648306796622 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008623648306796622 cfl multiplier : 0.7673105054214885        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9446e+04 |  512 |      1 | 2.633e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1001.6410187400315 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.234932763183999, dt = 0.008623648306796622 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.4%)
   patch tree reduce : 1134.00 ns (0.4%)
   gen split merge   : 833.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1042.00 ns (0.3%)
   LB compute        : 295.54 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.283933896700784e-17,-4.555828370805815e-17,3.764566783304169e-18)
    sum a = (-1.7025443554974374e-17,-1.075858152566056e-16,-1.3650213771809749e-17)
    sum e = 2.5920009858010977
    sum de = -2.0328790734103208e-19
Info: CFL hydro = 0.0094820742202196 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0094820742202196 cfl multiplier : 0.8448736702809923          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9334e+04 |  512 |      1 | 2.648e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1172.3445068719157 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.243556411490796, dt = 0.0094820742202196 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.08 us    (1.4%)
   patch tree reduce : 1662.00 ns (0.6%)
   gen split merge   : 742.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 805.00 ns  (0.3%)
   LB compute        : 279.48 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.64 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1918.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.287446711739637e-17,-4.7014638276249295e-17,3.483541580195926e-18)
    sum a = (7.358176568050823e-17,-4.028027911218146e-17,-6.505440717369248e-17)
    sum e = 2.5920009982145933
    sum de = 3.7947076036992655e-19
Info: CFL hydro = 0.010048973045306431 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010048973045306431 cfl multiplier : 0.8965824468539948        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0108e+04 |  512 |      1 | 2.546e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1340.6038424667934 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.2530384857110155, dt = 0.010048973045306431 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.5%)
   patch tree reduce : 1515.00 ns (0.5%)
   gen split merge   : 862.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 277.04 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1974.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.151032394397511e-17,-4.706879417476495e-17,2.5702096700941368e-18)
    sum a = (-6.218853557116155e-17,1.0674273964728087e-16,-3.541503028337001e-17)
    sum e = 2.592000998140595
    sum de = 7.182839392716467e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011176988692777513
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2417801162345476e-17,-4.641892339257714e-17,2.7195043092453906e-18)
    sum a = (6.00457183974612e-17,-3.508131285467897e-17,1.0279228640150406e-16)
    sum e = 2.5920008508529193
    sum de = -2.7647155398380363e-18
Info: CFL hydro = 0.0052121903335892415 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0052121903335892415 cfl multiplier : 0.4655274822846649       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4448e+04 |  512 |      1 | 3.544e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1020.817463279214 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.263087458756322, dt = 0.0052121903335892415 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (0.9%)
   patch tree reduce : 1170.00 ns (0.2%)
   gen split merge   : 679.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 923.00 ns  (0.2%)
   LB compute        : 461.78 us  (96.6%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.6%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1404939492809517e-17,-4.7010247257450734e-17,3.954844264575374e-18)
    sum a = (6.17435789995735e-17,-2.166235940626038e-17,-7.489175295541384e-17)
    sum e = 2.5920008905387153
    sum de = -1.0842021724855044e-19
Info: CFL hydro = 0.007203049091589405 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007203049091589405 cfl multiplier : 0.6436849881897766        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9622e+04 |  512 |      1 | 2.609e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 719.1139346469698 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.268299649089911, dt = 0.007203049091589405 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.3%)
   patch tree reduce : 1261.00 ns (0.4%)
   gen split merge   : 1109.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 891.00 ns  (0.3%)
   LB compute        : 314.88 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1118059597969853e-17,-4.727663573123042e-17,2.965401361965103e-18)
    sum a = (-3.750515523148756e-17,2.71657696337968e-18,2.579723544157697e-18)
    sum e = 2.5920009188896964
    sum de = 1.4094628242311558e-18
Info: CFL hydro = 0.008526999761534655 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008526999761534655 cfl multiplier : 0.7624566587931844        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9124e+04 |  512 |      1 | 2.677e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 968.5713147444563 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.2755026981815005, dt = 0.008526999761534655 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.49 us    (1.5%)
   patch tree reduce : 1435.00 ns (0.5%)
   gen split merge   : 734.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 277.69 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.71 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1952.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1726947538037712e-17,-4.7150759859004855e-17,3.237644527476213e-18)
    sum a = (-5.2048209492339126e-17,-5.479991460610733e-18,8.630172382393005e-17)
    sum e = 2.5920009372316537
    sum de = 4.0657581468206416e-20
Info: CFL hydro = 0.009407636793925204 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009407636793925204 cfl multiplier : 0.8416377725287895        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9547e+04 |  512 |      1 | 2.619e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1171.9707562999179 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.284029697943035, dt = 0.009407636793925204 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1387.00 ns (0.5%)
   gen split merge   : 899.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 276.75 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1927.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2242160410402825e-17,-4.71097770168849e-17,4.423219603089112e-18)
    sum a = (1.3519068677025903e-16,8.739883816666349e-17,-6.990867845550753e-18)
    sum e = 2.592000946502021
    sum de = 2.0328790734103208e-19
Info: CFL hydro = 0.009994397010865335 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009994397010865335 cfl multiplier : 0.8944251816858596        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9487e+04 |  512 |      1 | 2.627e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1288.984485069879 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.293437334736961, dt = 0.009994397010865335 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1200.00 ns (0.4%)
   gen split merge   : 727.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 956.00 ns  (0.3%)
   LB compute        : 291.17 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0046651011119678e-17,-4.602373170070617e-17,3.87287858033547e-18)
    sum a = (-4.777428452840127e-18,2.795029832580731e-17,-1.5218246584777774e-16)
    sum e = 2.592000950796839
    sum de = 1.6466320494623599e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010936868710337888
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0919000079101514e-17,-4.6375013204591473e-17,3.1527514973705984e-18)
    sum a = (-2.016941301474784e-17,-3.499934717043907e-17,2.7121859445811136e-18)
    sum e = 2.59200085137787
    sum de = 2.778268066994105e-19
Info: CFL hydro = 0.005194186352365178 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005194186352365178 cfl multiplier : 0.46480839389528655       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4596e+04 |  512 |      1 | 3.508e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1025.7401632495514 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.303431731747826, dt = 0.005194186352365178 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.3%)
   patch tree reduce : 1763.00 ns (0.6%)
   gen split merge   : 865.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 926.00 ns  (0.3%)
   LB compute        : 295.58 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.110635021450701e-17,-4.666189309943114e-17,3.899224693126868e-18)
    sum a = (2.322790397524255e-16,-2.189654707551725e-18,-7.748099037363509e-17)
    sum e = 2.592000877905527
    sum de = 2.0057740190981832e-18
Info: CFL hydro = 0.0071880894652135655 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0071880894652135655 cfl multiplier : 0.643205595930191        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9903e+04 |  512 |      1 | 2.572e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 726.8877988080873 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.308625918100191, dt = 0.0071880894652135655 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1493.00 ns (0.5%)
   gen split merge   : 673.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1668.00 ns (0.6%)
   LB compute        : 279.62 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.65 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1968.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.840584514446802e-18,-4.66794571746254e-17,3.0883498883249593e-18)
    sum a = (-1.1269988848400247e-16,4.561975797123807e-17,-1.4423033080357417e-17)
    sum e = 2.592000901023328
    sum de = -2.439454888092385e-19
Info: CFL hydro = 0.008518953216645891 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008518953216645891 cfl multiplier : 0.7621370639534607        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9519e+04 |  512 |      1 | 2.623e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 986.5030788483115 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.315814007565404, dt = 0.008518953216645891 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.96 us    (1.3%)
   patch tree reduce : 2.14 us    (0.7%)
   gen split merge   : 714.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 790.00 ns  (0.3%)
   LB compute        : 282.60 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1899.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0942418846027202e-17,-4.5971039475123374e-17,3.2112984146848156e-18)
    sum a = (2.2865498557067542e-17,1.3981003854635077e-16,-7.679891878692447e-17)
    sum e = 2.592000921410613
    sum de = 6.572975670693371e-19
Info: CFL hydro = 0.009409355677901517 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009409355677901517 cfl multiplier : 0.8414247093023072        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9559e+04 |  512 |      1 | 2.618e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1171.5364472911788 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.3243329607820495, dt = 0.009409355677901517 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1145.00 ns (0.4%)
   gen split merge   : 782.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 273.30 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1903.00 ns (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0116907311896739e-17,-4.469764402353915e-17,2.2394195872688095e-18)
    sum a = (-4.28504887822756e-17,-6.076584548042607e-17,3.0005295123536336e-18)
    sum e = 2.5920009402755952
    sum de = -3.9979955110402976e-19
Info: CFL hydro = 0.010007705441232431 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010007705441232431 cfl multiplier : 0.8942831395348714        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0252e+04 |  512 |      1 | 2.528e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1339.838925921344 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.333742316459951, dt = 0.010007705441232431 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.3%)
   patch tree reduce : 1243.00 ns (0.4%)
   gen split merge   : 680.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 779.00 ns  (0.3%)
   LB compute        : 290.76 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.65 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0714085868501754e-17,-4.6026659046571884e-17,2.6199745498112214e-18)
    sum a = (-1.0173112352518387e-16,7.83182112912284e-17,1.632112413968434e-16)
    sum e = 2.5920009599826597
    sum de = -1.4772254600114998e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.011055653627225147
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1235153432598289e-17,-4.539727968544405e-17,3.471832196733082e-18)
    sum a = (-2.4496030204268494e-17,1.1358101958958143e-18,2.5564511445252957e-17)
    sum e = 2.5920008565244337
    sum de = -1.4365678785432934e-18
Info: CFL hydro = 0.0052070391100537 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0052070391100537 cfl multiplier : 0.4647610465116238          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4795e+04 |  512 |      1 | 3.461e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1041.0882180816654 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.343750021901183, dt = 0.0052070391100537 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1256.00 ns (0.4%)
   gen split merge   : 731.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1130.00 ns (0.4%)
   LB compute        : 271.30 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1934.00 ns (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0825325011398768e-17,-4.5628540008835204e-17,2.9390552491737055e-18)
    sum a = (1.309811634153668e-16,-1.3120364170116083e-17,5.312254542505501e-17)
    sum e = 2.592000883680536
    sum de = 1.4907779871675686e-19
Info: CFL hydro = 0.007210301230634598 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007210301230634598 cfl multiplier : 0.6431740310077493        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9406e+04 |  512 |      1 | 2.638e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 710.4974591864938 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.3489570610112365, dt = 0.007210301230634598 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.4%)
   patch tree reduce : 1219.00 ns (0.4%)
   gen split merge   : 774.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 900.00 ns  (0.3%)
   LB compute        : 289.52 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1986.00 ns (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.344088003349071e-18,-4.589492848261489e-17,3.3605930538360694e-18)
    sum a = (-4.4601041609970695e-17,3.8516553228090666e-17,1.3316496343118711e-16)
    sum e = 2.592000915198519
    sum de = -1.1418004128987969e-18
Info: CFL hydro = 0.008551942855660485 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008551942855660485 cfl multiplier : 0.7621160206718329        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9831e+04 |  512 |      1 | 2.582e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1005.3959506997195 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.356167362241871, dt = 0.008551942855660485 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1620.00 ns (0.6%)
   gen split merge   : 932.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 891.00 ns  (0.3%)
   LB compute        : 274.50 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.57 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0444770048856355e-17,-4.545875394862398e-17,4.929650437857091e-18)
    sum a = (-2.1821607021355048e-16,-1.054576348122338e-17,6.703622032477874e-18)
    sum e = 2.592000948545386
    sum de = 5.082197683525802e-20
Info: CFL hydro = 0.009454081280471384 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009454081280471384 cfl multiplier : 0.8414106804478886        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9555e+04 |  512 |      1 | 2.618e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1175.8382582320244 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.364719305097532, dt = 0.009454081280471384 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.5%)
   patch tree reduce : 1434.00 ns (0.5%)
   gen split merge   : 761.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1024.00 ns (0.3%)
   LB compute        : 292.14 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3495064440927074e-17,-4.559633920431239e-17,4.3924824714991484e-18)
    sum a = (-5.821905457725762e-17,-3.008140611604482e-17,-1.636386338932372e-17)
    sum e = 2.5920009828893735
    sum de = -1.6127507315721878e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010423181552250116
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2821774891813576e-17,-4.5587557166715254e-17,4.314907806057811e-18)
    sum a = (-8.477593627098656e-17,3.515156915545603e-17,-1.906287627750913e-17)
    sum e = 2.5920008593998904
    sum de = 1.0621793158568926e-18
Info: CFL hydro = 0.005032652053845823 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005032652053845823 cfl multiplier : 0.44713689348262947       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4360e+04 |  512 |      1 | 3.566e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 954.5400536504028 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.374173386378003, dt = 0.005032652053845823 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.4%)
   patch tree reduce : 1449.00 ns (0.5%)
   gen split merge   : 677.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 966.00 ns  (0.3%)
   LB compute        : 294.64 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1963.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3190620470893143e-17,-4.5166019362052886e-17,4.241724159415039e-18)
    sum a = (1.0234001146525173e-17,-1.17503663049634e-16,-1.0942418846027202e-16)
    sum e = 2.592000893683374
    sum de = 6.954140496957806e-19
Info: CFL hydro = 0.007113405632927981 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007113405632927981 cfl multiplier : 0.6314245956550862        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9439e+04 |  512 |      1 | 2.634e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 687.8620670298792 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.379206038431849, dt = 0.007113405632927981 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.71 us    (1.5%)
   patch tree reduce : 1416.00 ns (0.5%)
   gen split merge   : 700.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1135.00 ns (0.4%)
   LB compute        : 293.38 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1909.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2675407598528032e-17,-4.640135931738287e-17,3.20983474175196e-18)
    sum a = (-5.601769048624306e-17,4.7294199806424685e-17,1.8174134072679316e-16)
    sum e = 2.59200093654003
    sum de = 1.4315915599781744e-18
Info: CFL hydro = 0.008509291076801834 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008509291076801834 cfl multiplier : 0.7542830637700574        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9388e+04 |  512 |      1 | 2.641e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 969.7106812515884 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.386319444064776, dt = 0.008509291076801834 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.5%)
   patch tree reduce : 1537.00 ns (0.5%)
   gen split merge   : 751.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 965.00 ns  (0.3%)
   LB compute        : 295.04 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3623867659018352e-17,-4.557877512911812e-17,5.70539709227047e-18)
    sum a = (5.922606155506216e-17,1.4625019945091466e-17,1.2339933762317566e-16)
    sum e = 2.5920009810599827
    sum de = 9.918755812347857e-19
Info: CFL hydro = 0.009432308807975388 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009432308807975388 cfl multiplier : 0.8361887091800382        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9097e+04 |  512 |      1 | 2.681e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1142.5747370317483 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.394828735141578, dt = 0.009432308807975388 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.4%)
   patch tree reduce : 1602.00 ns (0.5%)
   gen split merge   : 814.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1041.00 ns (0.4%)
   LB compute        : 278.86 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1773.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2332908132239862e-17,-4.535336949745838e-17,6.617265329439403e-18)
    sum a = (-9.390925537200445e-17,-5.735256020100721e-17,3.9243998675719814e-17)
    sum e = 2.5920010233618442
    sum de = -1.353558649712372e-18
Info: CFL hydro = 0.010045045745989396 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010045045745989396 cfl multiplier : 0.8907924727866922        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9898e+04 |  512 |      1 | 2.573e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1319.6650402779167 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.404261043949553, dt = 0.010045045745989396 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.73 us    (1.2%)
   patch tree reduce : 1094.00 ns (0.4%)
   gen split merge   : 824.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 941.00 ns  (0.3%)
   LB compute        : 292.42 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.406296953887498e-17,-4.642185073844285e-17,6.6919126490150306e-18)
    sum a = (-2.871140825089213e-17,-3.606490106555782e-18,1.5925932447813372e-16)
    sum e = 2.5920010615381828
    sum de = -1.446732273910345e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010968206018192006
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3658995809406882e-17,-4.6070569234557544e-17,7.373984235725662e-18)
    sum a = (-7.690723058395576e-17,2.380517657996073e-17,-9.145028484480733e-17)
    sum e = 2.592000865413543
    sum de = 7.250602028496811e-19
Info: CFL hydro = 0.0052272734048501345 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0052272734048501345 cfl multiplier : 0.4635974909288974       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4555e+04 |  512 |      1 | 3.518e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1028.0315331376994 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.414306089695542, dt = 0.0052272734048501345 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1222.00 ns (0.4%)
   gen split merge   : 751.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 944.00 ns  (0.3%)
   LB compute        : 293.30 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1973.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4349849433714644e-17,-4.591834724954058e-17,5.6087946787020115e-18)
    sum a = (4.496403249731884e-18,-2.2599110083287854e-17,-4.0467629247586955e-17)
    sum e = 2.592000917519764
    sum de = -6.572975670693371e-19
Info: CFL hydro = 0.0072430320412491585 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0072430320412491585 cfl multiplier : 0.6423983272859316       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9568e+04 |  512 |      1 | 2.617e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 719.2074691613095 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.419533363100393, dt = 0.0072430320412491585 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.65 us    (1.6%)
   patch tree reduce : 1206.00 ns (0.4%)
   gen split merge   : 769.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1006.00 ns (0.3%)
   LB compute        : 283.34 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.413322583965204e-17,-4.615253491879745e-17,5.465354731282179e-18)
    sum a = (6.6275110399693915e-18,-4.648625234748849e-17,6.285597042854363e-17)
    sum e = 2.5920009723207476
    sum de = -2.710505431213761e-19
Info: CFL hydro = 0.008587239660397797 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008587239660397797 cfl multiplier : 0.7615988848572878        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9317e+04 |  512 |      1 | 2.650e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 983.7867400169739 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.426776395141642, dt = 0.008587239660397797 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.99 us    (1.3%)
   patch tree reduce : 1662.00 ns (0.5%)
   gen split merge   : 767.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 975.00 ns  (0.3%)
   LB compute        : 292.85 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.422397356148908e-17,-4.66238376031769e-17,6.304039321808341e-18)
    sum a = (-2.407449239960613e-17,1.2262066362289657e-16,1.9777148668742584e-17)
    sum e = 2.592001022616426
    sum de = 1.3010426069826053e-18
Info: CFL hydro = 0.009484646985395076 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009484646985395076 cfl multiplier : 0.8410659232381917        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9663e+04 |  512 |      1 | 2.604e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1187.2162932655651 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.43536363480204, dt = 0.009484646985395076 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.3%)
   patch tree reduce : 1673.00 ns (0.5%)
   gen split merge   : 776.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 923.00 ns  (0.3%)
   LB compute        : 304.00 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4440597155551682e-17,-4.4738626865659106e-17,6.331849107532594e-18)
    sum a = (1.2369792690147819e-16,3.997583514214753e-17,7.024459139359784e-17)
    sum e = 2.59200106350635
    sum de = 5.285485590866834e-19
Info: CFL hydro = 0.01008513179002938 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01008513179002938 cfl multiplier : 0.8940439488254611         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9206e+04 |  512 |      1 | 2.666e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1280.8191135746997 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.444848281787435, dt = 0.01008513179002938 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.3%)
   patch tree reduce : 1174.00 ns (0.4%)
   gen split merge   : 653.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 287.73 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1954.00 ns (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2461711350331139e-17,-4.4680079948344886e-17,7.344710777068552e-18)
    sum a = (-2.393866355143714e-16,4.1287286089985996e-17,1.0505658842863141e-16)
    sum e = 2.592001093271991
    sum de = 5.624298769768554e-19
Info: CFL hydro = 0.010488528893173454 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010488528893173454 cfl multiplier : 0.9293626325503075        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9537e+04 |  512 |      1 | 2.621e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1385.3943597986815 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.454933413577464, dt = 0.010488528893173454 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1053.00 ns (0.4%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1441.00 ns (0.5%)
   LB compute        : 277.02 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6934695833137336e-17,-4.4116565869195546e-17,8.629815612115621e-18)
    sum a = (4.746984055836734e-17,-6.681374203898472e-17,5.472965830533027e-17)
    sum e = 2.5920011117723685
    sum de = -8.809142651444724e-20
Info: CFL hydro = 0.010761278385042365 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010761278385042365 cfl multiplier : 0.952908421700205         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9494e+04 |  512 |      1 | 2.626e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1437.6281555821554 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.465421942470638, dt = 0.010761278385042365 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.4%)
   patch tree reduce : 1303.00 ns (0.4%)
   gen split merge   : 859.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 861.00 ns  (0.3%)
   LB compute        : 281.90 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.71 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4750895817317033e-17,-4.549534577194536e-17,9.000124864128045e-18)
    sum a = (-6.16381945484079e-17,4.6064714542826126e-17,7.938961987807858e-18)
    sum e = 2.5920011197731174
    sum de = -2.371692252312041e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010708361236145679
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5447604133356217e-17,-4.4898167215340347e-17,8.708853950489815e-18)
    sum a = (-1.8243219435110093e-17,1.0519710103018553e-16,-4.601787700897475e-17)
    sum e = 2.592000867180882
    sum de = 1.5449880957918438e-18
Info: CFL hydro = 0.005469134584406574 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005469134584406574 cfl multiplier : 0.48430280723340163       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4879e+04 |  512 |      1 | 3.441e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1125.8438520742206 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.47618322085568, dt = 0.005469134584406574 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.18 us    (1.7%)
   patch tree reduce : 1317.00 ns (0.4%)
   gen split merge   : 797.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 950.00 ns  (0.3%)
   LB compute        : 286.01 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1884.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5378811505512015e-17,-4.406680098947846e-17,8.221450863848955e-18)
    sum a = (2.4870730475079483e-17,4.224745553393916e-17,7.974090138196388e-18)
    sum e = 2.5920009320954414
    sum de = 6.2341624917916505e-19
Info: CFL hydro = 0.007405443266626415 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007405443266626415 cfl multiplier : 0.6562018714889345        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9396e+04 |  512 |      1 | 2.640e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 745.8727301535533 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.481652355440087, dt = 0.007405443266626415 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1278.00 ns (0.4%)
   gen split merge   : 721.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 872.00 ns  (0.3%)
   LB compute        : 284.94 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1882.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.499532919710389e-17,-4.389408758340152e-17,8.324639805615264e-18)
    sum a = (1.778421160336663e-16,6.184896345073909e-17,2.611192512214089e-18)
    sum e = 2.5920009817917884
    sum de = -9.215718466126788e-19
Info: CFL hydro = 0.008691765084198255 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008691765084198255 cfl multiplier : 0.7708012476592897        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9227e+04 |  512 |      1 | 2.663e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1001.1632882597137 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.489057798706713, dt = 0.008691765084198255 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 1371.00 ns (0.4%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1461.00 ns (0.5%)
   LB compute        : 290.34 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.58 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2834947948209275e-17,-4.3302763718527923e-17,8.292439001092445e-18)
    sum a = (6.030332483364376e-17,-1.2053639336651045e-16,4.138096115768874e-17)
    sum e = 2.5920010179704183
    sum de = 4.607859233063394e-19
Info: CFL hydro = 0.009545622773686643 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009545622773686643 cfl multiplier : 0.8472008317728598        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9598e+04 |  512 |      1 | 2.612e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1197.7386423437392 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.4977495637909115, dt = 0.002250436209088491 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.78 us    (1.6%)
   patch tree reduce : 1213.00 ns (0.4%)
   gen split merge   : 725.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1275.00 ns (0.4%)
   LB compute        : 280.70 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.40 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1905.00 ns (63.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3222821275415964e-17,-4.433099395385887e-17,8.669334781302717e-18)
    sum a = (-5.627529692242561e-17,-1.8617919705921082e-17,-2.292697282024747e-17)
    sum e = 2.5920008764563125
    sum de = -1.362028979184915e-18
Info: CFL hydro = 0.010118415079401191 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010118415079401191 cfl multiplier : 0.8981338878485733        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9441e+04 |  512 |      1 | 2.634e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 307.6188632048116 (tsim/hr)                             [sph::Model][rank=0]
Info: iteration since start : 998                                                     [SPH][rank=0]
Info: time since start : 1767.861587954 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14981413499457788 max=0.1501952696900517 delta=0.0003811346954738226
Number of particle pairs: 130816
Distance min=0.146812 max=1.993644 mean=0.806030
---------------- t = 7.5, dt = 0.010118415079401191 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.29 us    (1.7%)
   patch tree reduce : 1317.00 ns (0.2%)
   gen split merge   : 854.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 822.00 ns  (0.1%)
   LB compute        : 529.41 us  (95.9%)
   LB move op cnt    : 0
   LB apply          : 3.99 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.53 us    (75.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3928311629052282e-17,-4.442210759392912e-17,8.424169565049432e-18)
    sum a = (-7.262159623655507e-17,-7.126330775486523e-17,3.9039084465120056e-17)
    sum e = 2.592001059813876
    sum de = 9.75781955236954e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.0105678478353093
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4026377715553594e-17,-4.4602505282903546e-17,8.604933172257079e-18)
    sum a = (1.351262851612134e-17,1.0924854770832937e-16,1.7498502646873249e-16)
    sum e = 2.5920008674853623
    sum de = 1.0706496453294356e-18
Info: CFL hydro = 0.005247040222307924 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005247040222307924 cfl multiplier : 0.4660446292828578        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.3344e+04 |  512 |      1 | 3.837e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 949.3774061065039 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.510118415079401, dt = 0.005247040222307924 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.08 us    (1.7%)
   patch tree reduce : 1335.00 ns (0.4%)
   gen split merge   : 729.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1290.00 ns (0.4%)
   LB compute        : 282.87 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3402853046157182e-17,-4.326617189520654e-17,1.0258151749917288e-17)
    sum a = (-2.09129588646384e-17,7.697748688473282e-17,9.33589143492508e-17)
    sum e = 2.592000918618623
    sum de = 5.149960319306146e-19
Info: CFL hydro = 0.007248841972902025 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007248841972902025 cfl multiplier : 0.6440297528552384        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9382e+04 |  512 |      1 | 2.642e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 715.0797415504104 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.515365455301709, dt = 0.007248841972902025 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.2%)
   patch tree reduce : 1321.00 ns (0.4%)
   gen split merge   : 727.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 836.00 ns  (0.2%)
   LB compute        : 323.76 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.366924151993687e-17,-4.2837590164554807e-17,1.0754336874155279e-17)
    sum a = (3.5327209907398684e-17,-1.2678920413566885e-16,1.2529040305242488e-18)
    sum e = 2.5920009580488013
    sum de = -5.21772295508649e-19
Info: CFL hydro = 0.008581967151894241 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008581967151894241 cfl multiplier : 0.7626865019034922        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0133e+04 |  512 |      1 | 2.543e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1026.1330644165448 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.522614297274611, dt = 0.008581967151894241 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.4%)
   patch tree reduce : 1274.00 ns (0.4%)
   gen split merge   : 737.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1237.00 ns (0.4%)
   LB compute        : 292.12 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3225748621281675e-17,-4.464531771618957e-17,1.04433063759235e-17)
    sum a = (-1.3550098543202439e-16,2.611192512214089e-17,-8.7586188302069e-18)
    sum e = 2.592000985210703
    sum de = -9.893344823930228e-19
Info: CFL hydro = 0.009468605520587762 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009468605520587762 cfl multiplier : 0.8417910012689948        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9403e+04 |  512 |      1 | 2.639e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1170.801894167113 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.531196264426505, dt = 0.009468605520587762 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1232.00 ns (0.4%)
   gen split merge   : 1154.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 934.00 ns  (0.3%)
   LB compute        : 289.47 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.65 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5230980539293614e-17,-4.363831073838503e-17,1.026583603281478e-17)
    sum a = (5.919093340467363e-18,6.889801229537085e-17,-6.786758655064062e-17)
    sum e = 2.5920009992318813
    sum de = -1.5720931501039814e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010055903457096074
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.454744527965013e-17,-4.341253918849208e-17,1.0026159590059702e-17)
    sum a = (-3.897468285607442e-17,-1.1177777453630356e-16,-5.1509577853048326e-17)
    sum e = 2.5920008673833768
    sum de = -9.486769009248164e-19
Info: CFL hydro = 0.005024747057546135 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005024747057546135 cfl multiplier : 0.447263667089665         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4723e+04 |  512 |      1 | 3.478e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 980.209878800528 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 7.540664869947093, dt = 0.005024747057546135 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.5%)
   patch tree reduce : 1253.00 ns (0.4%)
   gen split merge   : 706.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 887.00 ns  (0.3%)
   LB compute        : 277.41 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4929463915125395e-17,-4.480668765703688e-17,9.82783190765779e-18)
    sum a = (1.3106898379133812e-16,1.6416555614906514e-17,3.643960133636881e-17)
    sum e = 2.592000904372303
    sum de = 5.149960319306146e-19
Info: CFL hydro = 0.007090139313683112 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007090139313683112 cfl multiplier : 0.6315091113931101        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9814e+04 |  512 |      1 | 2.584e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 700.0295082579617 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.545689617004639, dt = 0.007090139313683112 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.2%)
   patch tree reduce : 1898.00 ns (0.6%)
   gen split merge   : 773.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 962.00 ns  (0.3%)
   LB compute        : 319.71 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3549220339442724e-17,-4.435221721138527e-17,1.0253028894652294e-17)
    sum a = (9.00685775961918e-17,7.34412530789541e-17,6.677861388859618e-17)
    sum e = 2.5920009356599714
    sum de = 1.0842021724855044e-18
Info: CFL hydro = 0.00846254600449165 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00846254600449165 cfl multiplier : 0.7543394075954067         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9427e+04 |  512 |      1 | 2.636e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 968.4715114987872 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.552779756318322, dt = 0.00846254600449165 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.5%)
   patch tree reduce : 1199.00 ns (0.4%)
   gen split merge   : 648.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 905.00 ns  (0.3%)
   LB compute        : 276.26 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3097677239656824e-17,-4.358964361336759e-17,1.090619294093903e-17)
    sum a = (-1.86531942236029e-16,8.477593627098656e-17,2.985892783025079e-18)
    sum e = 2.5920009583193604
    sum de = -1.260385025514399e-18
Info: CFL hydro = 0.009373969019242787 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009373969019242787 cfl multiplier : 0.8362262717302711        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9877e+04 |  512 |      1 | 2.576e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1182.7492166457482 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.561242302322814, dt = 0.009373969019242787 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.49 us    (1.5%)
   patch tree reduce : 1291.00 ns (0.4%)
   gen split merge   : 741.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1396.00 ns (0.5%)
   LB compute        : 283.79 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.55 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5966476188053468e-17,-4.282999736121562e-17,1.0598455706806176e-17)
    sum a = (5.3178164996503515e-17,4.871103520542874e-17,2.414474870038319e-17)
    sum e = 2.5920009723425017
    sum de = 3.5914196963582334e-19
Info: CFL hydro = 0.009979560264181094 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009979560264181094 cfl multiplier : 0.8908175144868474        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9467e+04 |  512 |      1 | 2.630e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1283.1064457572406 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.570616271342057, dt = 0.009979560264181094 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.5%)
   patch tree reduce : 1245.00 ns (0.4%)
   gen split merge   : 875.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 971.00 ns  (0.3%)
   LB compute        : 278.98 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.425471069307904e-17,-4.238796813549328e-17,1.1100678481892196e-17)
    sum a = (-4.138096115768874e-17,1.0657880827880106e-16,5.0947527446831843e-17)
    sum e = 2.592000980984832
    sum de = -1.0503208545953324e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010486264072197203
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4690885227069962e-17,-4.2226964112879186e-17,1.1244850265778455e-17)
    sum a = (-1.1238080778464e-16,5.992862456283277e-17,-6.5572547391923305e-18)
    sum e = 2.5920008680148885
    sum de = -1.3145951341386741e-18
Info: CFL hydro = 0.00519206392037948 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00519206392037948 cfl multiplier : 0.4636058381622825         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4466e+04 |  512 |      1 | 3.539e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1015.0612464237824 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.580595831606238, dt = 0.00519206392037948 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.65 us    (1.4%)
   patch tree reduce : 1241.00 ns (0.4%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 312.60 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.41 us    (70.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.562324488529887e-17,-4.21508531203707e-17,1.0910035082387776e-17)
    sum a = (-1.2318271402911308e-16,1.42784221945913e-16,-1.0943589784373486e-16)
    sum e = 2.592000898231309
    sum de = 1.4264034831762418e-18
Info: CFL hydro = 0.007193422002298084 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007193422002298084 cfl multiplier : 0.6424038921081884        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9445e+04 |  512 |      1 | 2.633e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 709.8621557485559 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.585787895526617, dt = 0.007193422002298084 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1133.00 ns (0.4%)
   gen split merge   : 774.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 952.00 ns  (0.3%)
   LB compute        : 288.41 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.39 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6772228137590382e-17,-4.1022361289139167e-17,9.76891907211036e-18)
    sum a = (-4.019831342794156e-17,-9.051353416777986e-17,-3.032730316876453e-18)
    sum e = 2.5920009254692635
    sum de = 4.2351647362715017e-19
Info: CFL hydro = 0.008527544518048838 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008527544518048838 cfl multiplier : 0.7616025947387923        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9621e+04 |  512 |      1 | 2.609e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 992.4125678394346 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.592981317528915, dt = 0.008527544518048838 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.4%)
   patch tree reduce : 1092.00 ns (0.4%)
   gen split merge   : 669.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1000.00 ns (0.3%)
   LB compute        : 289.54 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.70 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1919.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6740027333067563e-17,-4.252701706411455e-17,1.0068240186879296e-17)
    sum a = (3.0912772341906703e-18,-4.044421048066127e-17,1.0270300235259988e-16)
    sum e = 2.5920009492544005
    sum de = 1.5111067779016718e-18
Info: CFL hydro = 0.00941821221072264 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00941821221072264 cfl multiplier : 0.8410683964925282         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9077e+04 |  512 |      1 | 2.684e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1143.8666359953904 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.601508862046964, dt = 0.00941821221072264 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.4%)
   patch tree reduce : 1381.00 ns (0.5%)
   gen split merge   : 725.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 918.00 ns  (0.3%)
   LB compute        : 278.04 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6381427464517982e-17,-4.2592882346093044e-17,1.1543988421430783e-17)
    sum a = (2.6428078475637662e-17,-9.458839961284937e-17,-3.3781571290303345e-17)
    sum e = 2.5920009698308837
    sum de = -1.65849051072392e-18
Info: CFL hydro = 0.010014744645105362 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010014744645105362 cfl multiplier : 0.8940455976616853        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9324e+04 |  512 |      1 | 2.650e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1279.6684413120713 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.610927074257687, dt = 0.010014744645105362 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.5%)
   patch tree reduce : 1458.00 ns (0.5%)
   gen split merge   : 706.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 888.00 ns  (0.3%)
   LB compute        : 272.98 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6189686310313922e-17,-4.3702346429197455e-17,1.0483923299810238e-17)
    sum a = (4.0725235683769514e-17,-4.882812904005718e-17,5.356457465077735e-17)
    sum e = 2.592000988893679
    sum de = -1.4450382080158364e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010074582441025267
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.61838316185825e-17,-4.3380338383969264e-17,1.0991085971044645e-17)
    sum a = (-3.817259008886964e-17,5.700127869712191e-17,-9.265635134148021e-17)
    sum e = 2.5920008720109573
    sum de = -3.6422416731934915e-19
Info: CFL hydro = 0.00520500256818648 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00520500256818648 cfl multiplier : 0.46468186588722843        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4669e+04 |  512 |      1 | 3.490e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1032.9265322622518 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.620941818902793, dt = 0.00520500256818648 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 1672.00 ns (0.6%)
   gen split merge   : 802.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 864.00 ns  (0.3%)
   LB compute        : 278.79 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6726854276671864e-17,-4.266606599273581e-17,9.629504225255881e-18)
    sum a = (-2.4027654865754753e-16,9.088823443859084e-17,8.832387946022813e-17)
    sum e = 2.592000902853327
    sum de = 2.602826367794058e-18
Info: CFL hydro = 0.007203283996957099 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007203283996957099 cfl multiplier : 0.643121243924819         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9715e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 721.5069115873509 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.6261468214709796, dt = 0.007203283996957099 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.4%)
   patch tree reduce : 1362.00 ns (0.4%)
   gen split merge   : 718.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 867.00 ns  (0.3%)
   LB compute        : 287.86 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.9042384856449156e-17,-4.2016195210548e-17,1.0809956445603786e-17)
    sum a = (-6.018623099901532e-18,-7.527962628262053e-17,5.1767184289230885e-17)
    sum e = 2.5920009355442364
    sum de = -1.266314256145179e-18
Info: CFL hydro = 0.008535952735278497 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008535952735278497 cfl multiplier : 0.7620808292832125        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9520e+04 |  512 |      1 | 2.623e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 988.6364508183186 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.633350105467937, dt = 0.008535952735278497 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.27 us    (1.8%)
   patch tree reduce : 1370.00 ns (0.5%)
   gen split merge   : 698.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 992.00 ns  (0.3%)
   LB compute        : 278.49 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.31 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.799146769065896e-17,-4.3213479669623746e-17,1.11641652953548e-17)
    sum a = (-1.3023176287374482e-16,-1.949612346563434e-18,1.3399632965704899e-16)
    sum e = 2.5920009673122544
    sum de = 2.761327408049019e-19
Info: CFL hydro = 0.009426035918106208 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009426035918106208 cfl multiplier : 0.8413872195221416        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9807e+04 |  512 |      1 | 2.585e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1188.7728034298332 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.641886058203215, dt = 0.009426035918106208 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.97 us    (1.3%)
   patch tree reduce : 1768.00 ns (0.6%)
   gen split merge   : 714.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 878.00 ns  (0.3%)
   LB compute        : 296.88 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.98 us    (72.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.9844477623653932e-17,-4.304369360941251e-17,1.2834947948209275e-17)
    sum a = (4.75400968591444e-18,2.0202199288443801e-16,-8.272679416498895e-18)
    sum e = 2.592000996774621
    sum de = -7.352245982167327e-19
Info: CFL hydro = 0.010022387669063586 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010022387669063586 cfl multiplier : 0.8942581463480943        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9788e+04 |  512 |      1 | 2.587e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1311.460031616215 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.651312094121321, dt = 0.010022387669063586 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.4%)
   patch tree reduce : 1243.00 ns (0.4%)
   gen split merge   : 986.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 966.00 ns  (0.3%)
   LB compute        : 276.52 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.36 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1957.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.918289745800328e-17,-3.999925390907322e-17,1.2027000489273077e-17)
    sum a = (-1.1407281369502087e-16,-3.597122599785507e-17,-2.3254835557207087e-17)
    sum e = 2.5920010236780766
    sum de = 3.7608262858090935e-19
Info: CFL hydro = 0.01042415620411135 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01042415620411135 cfl multiplier : 0.9295054308987295         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9685e+04 |  512 |      1 | 2.601e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1387.165684695252 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.661334481790385, dt = 0.01042415620411135 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.88 us    (1.2%)
   patch tree reduce : 1310.00 ns (0.4%)
   gen split merge   : 671.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 300.17 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.098321516541546e-17,-4.158294802242279e-17,1.1799399348214056e-17)
    sum a = (3.107670371038651e-17,-1.3881913197080764e-16,9.459279063164794e-17)
    sum e = 2.5920010478303945
    sum de = 5.89534931288993e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010398491087244206
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.0295288886973406e-17,-4.20688874361308e-17,1.2370231792027674e-17)
    sum a = (-5.742281650178426e-17,2.505808061048498e-17,-6.488681662288053e-17)
    sum e = 2.592000879639781
    sum de = -7.657177843178875e-19
Info: CFL hydro = 0.0053492065517025825 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0053492065517025825 cfl multiplier : 0.47650181029957644      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4649e+04 |  512 |      1 | 3.495e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1073.6812481826942 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.671758637994496, dt = 0.0053492065517025825 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.4%)
   patch tree reduce : 1667.00 ns (0.5%)
   gen split merge   : 684.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 935.00 ns  (0.3%)
   LB compute        : 299.34 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.49 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.47 us    (70.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.0930522939832664e-17,-4.11262820673719e-17,1.1066099208853486e-17)
    sum a = (2.992918413102785e-17,8.401775369176745e-17,-7.486054699108757e-17)
    sum e = 2.5920009229032437
    sum de = -4.472333961502706e-19
Info: CFL hydro = 0.007311923486386883 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007311923486386883 cfl multiplier : 0.6510012068663843        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9033e+04 |  512 |      1 | 2.690e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 715.8430717348921 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.677107844546199, dt = 0.007311923486386883 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.66 us    (1.6%)
   patch tree reduce : 1325.00 ns (0.5%)
   gen split merge   : 729.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 987.00 ns  (0.3%)
   LB compute        : 278.39 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.73 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.05089851351703e-17,-4.0365172142287075e-17,1.0558936537619079e-17)
    sum a = (-2.3418766925686896e-17,1.1925421587732909e-16,-4.6393309116252165e-17)
    sum e = 2.592000965586548
    sum de = -1.07742590890747e-18
Info: CFL hydro = 0.008619652429559302 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008619652429559302 cfl multiplier : 0.767334137910923         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9803e+04 |  512 |      1 | 2.586e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1018.0968481178625 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.684419768032585, dt = 0.008619652429559302 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.4%)
   patch tree reduce : 1386.00 ns (0.5%)
   gen split merge   : 827.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 938.00 ns  (0.3%)
   LB compute        : 277.12 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1947.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.0866121330787023e-17,-3.9261562750914083e-17,1.0240587674723022e-17)
    sum a = (-1.351262851612134e-17,1.4363900693870058e-16,-3.800280402865841e-17)
    sum e = 2.592001004375349
    sum de = 5.55653613398821e-19
Info: CFL hydro = 0.00949001172713178 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00949001172713178 cfl multiplier : 0.8448894252739487         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8988e+04 |  512 |      1 | 2.696e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1150.7852277310624 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.693039420462145, dt = 0.00949001172713178 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (0.9%)
   patch tree reduce : 1294.00 ns (0.2%)
   gen split merge   : 851.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 936.00 ns  (0.2%)
   LB compute        : 503.95 us  (96.6%)
   LB move op cnt    : 0
   LB apply          : 3.36 us    (0.6%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.31 us    (75.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.0942232323295505e-17,-3.794425711134419e-17,9.928825340024815e-18)
    sum a = (-8.7586188302069e-18,-1.1040777667115087e-16,1.5737411374061593e-17)
    sum e = 2.592001036210186
    sum de = 1.782157321023048e-18
Info: CFL hydro = 0.010071179195026725 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010071179195026725 cfl multiplier : 0.8965929501826325        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9464e+04 |  512 |      1 | 2.630e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1298.790094265737 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.7025294321892765, dt = 0.010071179195026725 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.84 us    (1.6%)
   patch tree reduce : 1496.00 ns (0.5%)
   gen split merge   : 822.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 998.00 ns  (0.3%)
   LB compute        : 294.37 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.49 us    (70.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.1097381654178182e-17,-4.007829224744741e-17,1.035036314468718e-17)
    sum a = (8.861661404679921e-17,-5.0643083476797915e-17,4.6252064678231615e-18)
    sum e = 2.592001060434071
    sum de = -7.657177843178875e-19
Info: CFL hydro = 0.010460470042110292 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010460470042110292 cfl multiplier : 0.9310619667884218        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9361e+04 |  512 |      1 | 2.644e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1371.026206408544 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.712600611384303, dt = 0.010460470042110292 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.08 us    (1.7%)
   patch tree reduce : 2.03 us    (0.7%)
   gen split merge   : 763.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 271.86 us  (93.6%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.9671764217576992e-17,-4.0262715036987196e-17,1.0310843975500084e-17)
    sum a = (1.0784342169278815e-16,1.48170538338821e-16,2.478876479083958e-17)
    sum e = 2.5920010773101874
    sum de = -3.1170812458958252e-19
Info: CFL hydro = 0.01071883136466314 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01071883136466314 cfl multiplier : 0.9540413111922813         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9670e+04 |  512 |      1 | 2.603e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1446.7309024176695 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.723061081426414, dt = 0.01071883136466314 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.71 us    (1.5%)
   patch tree reduce : 2.13 us    (0.7%)
   gen split merge   : 956.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 925.00 ns  (0.3%)
   LB compute        : 295.01 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.31 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.847740710436696e-17,-3.760761233678744e-17,1.0757996056487417e-17)
    sum a = (-2.3465604459538268e-17,2.2669366384064914e-17,1.404950374789271e-16)
    sum e = 2.592001087461408
    sum de = -1.1519648082658485e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010034215035669267
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.904531220231487e-17,-3.831017534455805e-17,1.135005175782744e-17)
    sum a = (-7.182535816108171e-17,-3.3781571290303345e-17,3.1738283876037163e-17)
    sum e = 2.59200088351841
    sum de = -1.8295911660692887e-19
Info: CFL hydro = 0.005445001439637443 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005445001439637443 cfl multiplier : 0.4846804370640938        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4611e+04 |  512 |      1 | 3.504e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1101.190841289071 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.733779912791077, dt = 0.005445001439637443 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1132.00 ns (0.4%)
   gen split merge   : 649.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 969.00 ns  (0.3%)
   LB compute        : 283.49 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.9630781375457042e-17,-3.883124290865458e-17,1.0856428061221945e-17)
    sum a = (1.4140251469729749e-16,-1.1458802656738597e-16,1.1032581098691097e-16)
    sum e = 2.592000935570964
    sum de = 1.8295911660692887e-19
Info: CFL hydro = 0.007374462550075938 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007374462550075938 cfl multiplier : 0.6564536247093958        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9992e+04 |  512 |      1 | 2.561e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 765.4093923030883 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.739224914230714, dt = 0.007374462550075938 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1457.00 ns (0.5%)
   gen split merge   : 661.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 292.97 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.77 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.38 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.8120270908750235e-17,-3.993338862709472e-17,1.1939911949768178e-17)
    sum a = (1.4824079463959806e-17,6.732895491134983e-17,-1.8196381901258717e-17)
    sum e = 2.59200097807968
    sum de = -2.710505431213761e-20
Info: CFL hydro = 0.008661574932632055 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008661574932632055 cfl multiplier : 0.7709690831395971        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9912e+04 |  512 |      1 | 2.571e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1032.4657000115571 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.74659937678079, dt = 0.008661574932632055 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.3%)
   patch tree reduce : 1602.00 ns (0.5%)
   gen split merge   : 715.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 968.00 ns  (0.3%)
   LB compute        : 317.16 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.35 us    (70.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.8600355630726816e-17,-3.869512132589903e-17,1.1268086073587535e-17)
    sum a = (1.2781962988039906e-16,3.290336753059009e-17,-8.255115341304631e-18)
    sum e = 2.5920010118122483
    sum de = 1.8566962203814263e-18
Info: CFL hydro = 0.009521765902427875 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009521765902427875 cfl multiplier : 0.8473127220930646        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9101e+04 |  512 |      1 | 2.681e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1163.2617499643968 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.755260951713423, dt = 0.009521765902427875 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.4%)
   patch tree reduce : 1528.00 ns (0.5%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 967.00 ns  (0.3%)
   LB compute        : 270.51 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.62 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6867366878225988e-17,-3.861754666045769e-17,1.128455239408216e-17)
    sum a = (1.5545377485270961e-16,-6.6743485738207655e-18,-2.7329701002276608e-17)
    sum e = 2.592001034886773
    sum de = 1.7889335846010823e-18
Info: CFL hydro = 0.010098719610642404 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010098719610642404 cfl multiplier : 0.8982084813953763        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9802e+04 |  512 |      1 | 2.586e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1325.756559579634 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.764782717615851, dt = 0.010098719610642404 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.83 us    (1.1%)
   patch tree reduce : 1175.00 ns (0.3%)
   gen split merge   : 1084.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 791.00 ns  (0.2%)
   LB compute        : 321.53 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.58 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5028993674559565e-17,-3.875220457028039e-17,1.0933819767546677e-17)
    sum a = (-8.983438992693493e-17,-1.0608701417336164e-16,3.607661044902066e-17)
    sum e = 2.5920010487235077
    sum de = 2.0803129184565616e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010242625838612365
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6182367945649645e-17,-3.923521663812268e-17,1.1274489642668777e-17)
    sum a = (-8.91786644530157e-17,-3.222422328974517e-17,-5.242290976315012e-17)
    sum e = 2.592000883139436
    sum de = 5.014435047745458e-19
Info: CFL hydro = 0.0052446483239902255 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0052446483239902255 cfl multiplier : 0.4660694937984588       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4696e+04 |  512 |      1 | 3.484e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1043.5058952444615 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.774881437226493, dt = 0.0052446483239902255 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 1396.00 ns (0.4%)
   gen split merge   : 671.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1057.00 ns (0.3%)
   LB compute        : 302.33 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.44 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.664488859243196e-17,-3.906689425084431e-17,1.0535426291135089e-17)
    sum a = (2.7868332641567407e-18,5.046744272485526e-17,-3.4285074779205614e-17)
    sum e = 2.5920009275005684
    sum de = -8.131516293641283e-19
Info: CFL hydro = 0.007250708658595368 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007250708658595368 cfl multiplier : 0.6440463291989725        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8740e+04 |  512 |      1 | 2.732e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 691.0546513806834 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.780126085550483, dt = 0.007250708658595368 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.48 us    (1.8%)
   patch tree reduce : 1294.00 ns (0.4%)
   gen split merge   : 866.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 963.00 ns  (0.3%)
   LB compute        : 283.35 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6451683765295045e-17,-3.842873285211934e-17,1.033901967945755e-17)
    sum a = (-1.290374057605348e-17,-8.351132285699947e-17,3.4624646899628075e-17)
    sum e = 2.592000965507469
    sum de = 8.402566836762659e-19
Info: CFL hydro = 0.00858723635848849 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00858723635848849 cfl multiplier : 0.762697552799315          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5943e+04 |  512 |      1 | 3.211e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 812.7926657689244 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.787376794209079, dt = 0.00858723635848849 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.96 us    (1.6%)
   patch tree reduce : 1793.00 ns (0.6%)
   gen split merge   : 784.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 285.90 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6627324517237694e-17,-3.96845642285093e-17,1.0959617002988254e-17)
    sum a = (7.91554322088217e-18,-1.157589649136703e-16,2.4718508490062518e-17)
    sum e = 2.5920009955418184
    sum de = 3.5914196963582334e-19
Info: CFL hydro = 0.009473044435064611 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009473044435064611 cfl multiplier : 0.8417983685328766        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9042e+04 |  512 |      1 | 2.689e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1149.7646895385149 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.795964030567568, dt = 0.009473044435064611 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.4%)
   patch tree reduce : 1808.00 ns (0.6%)
   gen split merge   : 761.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 971.00 ns  (0.3%)
   LB compute        : 308.20 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6639033900700538e-17,-4.083940217253224e-17,1.1057317171256353e-17)
    sum a = (2.1770085734118537e-16,5.287957571820101e-17,5.837127656227459e-17)
    sum e = 2.5920010163505327
    sum de = 2.981555974335137e-19
Info: CFL hydro = 0.010063077565126699 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010063077565126699 cfl multiplier : 0.8945322456885844        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9165e+04 |  512 |      1 | 2.672e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1276.5451543419729 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.805437075002632, dt = 0.010063077565126699 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.5%)
   patch tree reduce : 1243.00 ns (0.4%)
   gen split merge   : 672.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 946.00 ns  (0.3%)
   LB compute        : 276.03 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3132073553578927e-17,-3.9603330380735824e-17,1.1830868316270448e-17)
    sum a = (-3.4062596493411587e-17,1.3594594200361242e-16,-8.321858827042839e-17)
    sum e = 2.592001030157353
    sum de = -1.8295911660692887e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010355322403167425
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.466600278721142e-17,-3.919423379600273e-17,1.1170751823552649e-17)
    sum a = (-1.2174245986318333e-16,-2.0421164759198974e-17,8.513892715833471e-17)
    sum e = 2.5920008839188617
    sum de = -2.2090619264392153e-18
Info: CFL hydro = 0.005229353730761859 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005229353730761859 cfl multiplier : 0.4648440818961948        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4406e+04 |  512 |      1 | 3.554e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1019.2906598424897 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.8155001525677585, dt = 0.005229353730761859 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1251.00 ns (0.4%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 282.29 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.39 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5708137915404486e-17,-4.0056520112571187e-17,1.2481470934924688e-17)
    sum a = (-3.7013361126048136e-17,-7.564261716996867e-18,-3.6451310719831654e-17)
    sum e = 2.5920009230301946
    sum de = 7.860465750519907e-19
Info: CFL hydro = 0.007236247453583851 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007236247453583851 cfl multiplier : 0.6432293879307965        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9544e+04 |  512 |      1 | 2.620e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 718.6259672375803 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.8207295062985205, dt = 0.007236247453583851 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1912.00 ns (0.6%)
   gen split merge   : 761.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 931.00 ns  (0.3%)
   LB compute        : 277.45 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.569057384021022e-17,-4.010719978787131e-17,1.192673889337248e-17)
    sum a = (-8.720563333952658e-17,7.5244498132232e-17,-6.327750823320599e-17)
    sum e = 2.592000958203298
    sum de = -1.2874900798265365e-19
Info: CFL hydro = 0.0085753799403993 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0085753799403993 cfl multiplier : 0.7621529252871978          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0026e+04 |  512 |      1 | 2.557e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1018.9291500046609 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.827965753752104, dt = 0.0085753799403993 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.2%)
   patch tree reduce : 1716.00 ns (0.5%)
   gen split merge   : 792.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 938.00 ns  (0.3%)
   LB compute        : 315.59 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6650743284163382e-17,-3.9160569318547056e-17,1.1201488955142613e-17)
    sum a = (1.522029572688377e-16,1.0515026349633417e-16,3.9741647472890664e-17)
    sum e = 2.5920009879208914
    sum de = -2.541098841762901e-19
Info: CFL hydro = 0.0094706941382856 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0094706941382856 cfl multiplier : 0.8414352835247986          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9492e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1175.2766473868471 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.836541133692504, dt = 0.0094706941382856 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.77 us    (1.6%)
   patch tree reduce : 1293.00 ns (0.4%)
   gen split merge   : 718.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1294.00 ns (0.4%)
   LB compute        : 277.02 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.32 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4250319674280477e-17,-3.805641104982424e-17,1.2003581722347389e-17)
    sum a = (-6.946591739331876e-17,-1.1931861748637473e-16,-4.8617360137725995e-17)
    sum e = 2.5920010113804373
    sum de = -1.8634724839594607e-19
Info: CFL hydro = 0.01006807793458479 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01006807793458479 cfl multiplier : 0.8942901890165323         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9168e+04 |  512 |      1 | 2.671e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1276.4251460770404 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.8460118278307895, dt = 0.01006807793458479 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.90 us    (1.5%)
   patch tree reduce : 2.09 us    (0.6%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 962.00 ns  (0.3%)
   LB compute        : 317.58 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (71.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6047710035826946e-17,-4.027039931988469e-17,1.113855101902983e-17)
    sum a = (7.770932335116054e-17,-8.61342247526764e-17,9.880377765947301e-17)
    sum e = 2.5920010300190914
    sum de = 1.3433942543453203e-18
Info: CFL hydro = 0.010462063729920514 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010462063729920514 cfl multiplier : 0.9295267926776883        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8971e+04 |  512 |      1 | 2.699e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1343.0108663586639 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.856079905765374, dt = 0.010462063729920514 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.3%)
   patch tree reduce : 1236.00 ns (0.4%)
   gen split merge   : 963.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 925.00 ns  (0.3%)
   LB compute        : 296.46 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.37 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4449379193148814e-17,-4.097771926468707e-17,1.2845193658739262e-17)
    sum a = (-4.506941694848443e-17,4.2832924707081335e-17,-2.4905858625468015e-17)
    sum e = 2.592001045371677
    sum de = 6.183340514956392e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010222308927433168
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5105104667068047e-17,-4.0366635815219933e-17,1.2199713895350017e-17)
    sum a = (1.532992482955464e-16,-3.766908659996737e-17,-9.92604436145239e-17)
    sum e = 2.5920008879749292
    sum de = -3.902704304474189e-19
Info: CFL hydro = 0.005362876131623532 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005362876131623532 cfl multiplier : 0.4765089308925628        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.3895e+04 |  512 |      1 | 3.685e-02 | 0.1% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1022.1067982017835 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.8665419694952945, dt = 0.005362876131623532 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.65 us    (1.4%)
   patch tree reduce : 1535.00 ns (0.5%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1495.00 ns (0.5%)
   LB compute        : 310.93 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3173056395698879e-17,-4.0865016448857206e-17,1.1268817910053963e-17)
    sum a = (-9.285541086034855e-18,1.1678939065840055e-16,-2.0631933661530154e-17)
    sum e = 2.5920009286061525
    sum de = 9.58841296291868e-19
Info: CFL hydro = 0.007326556374574333 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007326556374574333 cfl multiplier : 0.6510059539283751        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8789e+04 |  512 |      1 | 2.725e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 708.4928657274941 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.871904845626918, dt = 0.007326556374574333 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.74 us    (1.5%)
   patch tree reduce : 1126.00 ns (0.3%)
   gen split merge   : 791.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1047.00 ns (0.3%)
   LB compute        : 305.17 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.32 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.361801296728693e-17,-3.96845642285093e-17,1.1249790161926842e-17)
    sum a = (3.963626302172507e-17,3.332490533525245e-17,9.563053474104243e-17)
    sum e = 2.5920009663361747
    sum de = 7.809643773684649e-19
Info: CFL hydro = 0.00863604579412565 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00863604579412565 cfl multiplier : 0.7673373026189166         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9157e+04 |  512 |      1 | 2.673e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 986.8828568005131 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.8792314020014915, dt = 0.00863604579412565 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.4%)
   patch tree reduce : 1340.00 ns (0.5%)
   gen split merge   : 690.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1017.00 ns (0.3%)
   LB compute        : 279.81 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3149637628773191e-17,-3.9683100555576445e-17,1.2511476230048224e-17)
    sum a = (-3.722413002837932e-17,-4.456591345958216e-17,-5.893332696849107e-17)
    sum e = 2.5920009999213085
    sum de = 4.573977915173222e-19
Info: CFL hydro = 0.00951013675864226 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00951013675864226 cfl multiplier : 0.8448915350792777         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9061e+04 |  512 |      1 | 2.686e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1157.4393725154036 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.887867447795617, dt = 0.00951013675864226 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.3%)
   patch tree reduce : 2.33 us    (0.8%)
   gen split merge   : 789.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 952.00 ns  (0.3%)
   LB compute        : 285.89 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3799508410961002e-17,-4.031760277196927e-17,1.129223667697965e-17)
    sum a = (-1.2646134139870925e-16,-1.2360425183377544e-16,8.594687461727091e-18)
    sum e = 2.5920010276766297
    sum de = -9.147955830346444e-20
Info: CFL hydro = 0.010094738729895077 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010094738729895077 cfl multiplier : 0.8965943567195186        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8933e+04 |  512 |      1 | 2.704e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1266.0215309725454 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.89737758455426, dt = 0.010094738729895077 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.3%)
   patch tree reduce : 1671.00 ns (0.6%)
   gen split merge   : 968.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1055.00 ns (0.3%)
   LB compute        : 286.22 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.55500612386561e-17,-4.206449641733223e-17,1.1775248744821942e-17)
    sum a = (1.999962695453661e-17,8.693046282814976e-17,3.427336539574277e-17)
    sum e = 2.5920010498102584
    sum de = -5.827586677109586e-19
Info: CFL hydro = 0.010482954842036214 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010482954842036214 cfl multiplier : 0.9310629044796791        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9130e+04 |  512 |      1 | 2.676e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1357.8018772846767 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.907472323284154, dt = 0.010482954842036214 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.76 us    (1.5%)
   patch tree reduce : 1308.00 ns (0.4%)
   gen split merge   : 1029.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 986.00 ns  (0.3%)
   LB compute        : 290.13 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1948.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4630874636822888e-17,-4.0086342448578115e-17,1.2248015102134247e-17)
    sum a = (1.0594650157180751e-16,3.019849995067325e-17,-8.635670303847043e-17)
    sum e = 2.592001066766897
    sum de = 1.2197274440461925e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010559657369529121
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4250319674280477e-17,-4.033516684716354e-17,1.1601071665812147e-17)
    sum a = (-6.262178275928675e-17,-1.484164353915407e-17,-2.6685684911820218e-17)
    sum e = 2.5920008920860216
    sum de = -6.098637220230962e-20
Info: CFL hydro = 0.005370677640642819 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005370677640642819 cfl multiplier : 0.477020968159893         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4377e+04 |  512 |      1 | 3.561e-02 | 0.1% |   2.3% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1059.7017012092203 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.917955278126191, dt = 0.005370677640642819 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.3%)
   patch tree reduce : 1558.00 ns (0.5%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1349.00 ns (0.4%)
   LB compute        : 317.21 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.41 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.542125802056482e-17,-4.073474955783307e-17,1.1747438959097689e-17)
    sum a = (-5.419102666603948e-17,-2.2291738767388213e-17,-5.744623526870995e-17)
    sum e = 2.5920009372236983
    sum de = 7.724940478959219e-19
Info: CFL hydro = 0.007333287182053327 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007333287182053327 cfl multiplier : 0.6513473121065952        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9618e+04 |  512 |      1 | 2.610e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 740.8165873207126 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.923325955766834, dt = 0.007333287182053327 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1430.00 ns (0.5%)
   gen split merge   : 666.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1013.00 ns (0.3%)
   LB compute        : 276.54 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1803.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5918906817735667e-17,-4.090234010864502e-17,1.1261499545389686e-17)
    sum a = (-3.114696001116357e-17,7.540916133717823e-17,-5.239949099622443e-17)
    sum e = 2.592000977741835
    sum de = 3.2526065174565133e-19
Info: CFL hydro = 0.00864208219605753 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00864208219605753 cfl multiplier : 0.76756487473773           [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9343e+04 |  512 |      1 | 2.647e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 997.3704711876737 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.930659242948887, dt = 0.00864208219605753 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.5%)
   patch tree reduce : 1732.00 ns (0.6%)
   gen split merge   : 727.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1082.00 ns (0.4%)
   LB compute        : 280.94 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.38 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.603014596063268e-17,-3.9888014766176204e-17,1.0810688282070213e-17)
    sum a = (8.798430733980566e-17,4.523042097109853e-17,5.2832738184349636e-17)
    sum e = 2.5920010119667785
    sum de = -1.5585406229479126e-18
Info: CFL hydro = 0.009515588560973958 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009515588560973958 cfl multiplier : 0.8450432498251533        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7336e+04 |  512 |      1 | 2.953e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1053.429926366625 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.939301325144944, dt = 0.009515588560973958 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.6%)
   patch tree reduce : 1507.00 ns (0.5%)
   gen split merge   : 645.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 998.00 ns  (0.4%)
   LB compute        : 266.34 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 3.76 us    (1.3%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1860.00 ns (64.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4657220749614285e-17,-3.966919566271432e-17,1.171523815457487e-17)
    sum a = (1.8877868018796206e-16,-2.0263088082450587e-17,4.346523141407488e-17)
    sum e = 2.592001037476812
    sum de = 3.1170812458958252e-19
Info: CFL hydro = 0.010099500542927823 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010099500542927823 cfl multiplier : 0.8966954998834357        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8980e+04 |  512 |      1 | 2.698e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1269.8994330144922 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.948816913705918, dt = 0.010099500542927823 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1314.00 ns (0.5%)
   gen split merge   : 635.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 949.00 ns  (0.3%)
   LB compute        : 269.54 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.38 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2283143252522777e-17,-4.019611791854227e-17,1.219239553068574e-17)
    sum a = (5.714179129867602e-17,9.571250042528235e-17,6.736408306173835e-17)
    sum e = 2.59200105451175
    sum de = -1.8566962203814263e-18
Info: CFL hydro = 0.010487776370394723 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010487776370394723 cfl multiplier : 0.9311303332556239        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9373e+04 |  512 |      1 | 2.643e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1375.7472653983348 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.958916414248845, dt = 0.010487776370394723 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.3%)
   patch tree reduce : 1040.00 ns (0.3%)
   gen split merge   : 800.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 320.97 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2356326899165548e-17,-3.861754666045769e-17,1.2991560952024805e-17)
    sum a = (2.1849709541665873e-17,4.4501511850536525e-17,1.0257419913450861e-17)
    sum e = 2.5920010641478584
    sum de = -6.776263578034403e-20
Info: CFL hydro = 0.010744723590411977 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010744723590411977 cfl multiplier : 0.9540868888370827        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9560e+04 |  512 |      1 | 2.618e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1442.3957331968286 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.96940419061924, dt = 0.010744723590411977 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.3%)
   patch tree reduce : 1421.00 ns (0.5%)
   gen split merge   : 682.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1056.00 ns (0.3%)
   LB compute        : 294.46 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1960.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2218741643477137e-17,-3.8478497731836425e-17,1.2774937357962202e-17)
    sum a = (-7.002211310780382e-18,-6.221195433808724e-17,4.2153780466236415e-18)
    sum e = 2.5920010678364243
    sum de = -2.439454888092385e-19
Info: CFL hydro = 0.010917527550994833 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010917527550994833 cfl multiplier : 0.9693912592247219        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9444e+04 |  512 |      1 | 2.633e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1469.0001892592413 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.980148914209653, dt = 0.010917527550994833 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.6%)
   patch tree reduce : 1144.00 ns (0.4%)
   gen split merge   : 727.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1513.00 ns (0.5%)
   LB compute        : 271.11 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2409019124748344e-17,-3.974896583755494e-17,1.2812992854216443e-17)
    sum a = (-8.360499792470221e-18,-5.0584536559483695e-17,7.212028825705207e-17)
    sum e = 2.5920010672028417
    sum de = -4.2012834183813297e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010158909343471327
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.249391215485396e-17,-3.964577689578863e-17,1.3181838433296012e-17)
    sum a = (2.028065215764485e-16,3.0409268853004434e-17,1.9081172189169826e-17)
    sum e = 2.592000892307237
    sum de = -1.5043305143236374e-18
Info: CFL hydro = 0.005518110491900383 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005518110491900383 cfl multiplier : 0.48979708640824066       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4681e+04 |  512 |      1 | 3.487e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1126.9748514483667 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 7.991066441760648, dt = 0.005518110491900383 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1296.00 ns (0.4%)
   gen split merge   : 682.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 843.00 ns  (0.3%)
   LB compute        : 282.49 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.36 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0269129296913703e-17,-3.901493386172794e-17,1.300619768135336e-17)
    sum a = (1.2318271402911307e-17,-7.758637482480068e-17,1.1070600003122016e-16)
    sum e = 2.5920009366507335
    sum de = 7.182839392716467e-19
Info: CFL hydro = 0.007435434064573702 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007435434064573702 cfl multiplier : 0.6598647242721604        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9599e+04 |  512 |      1 | 2.612e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 760.4321435942422 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 7.996584552252548, dt = 0.0034154477474519496 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.73 us    (1.2%)
   patch tree reduce : 978.00 ns  (0.3%)
   gen split merge   : 706.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 999.00 ns  (0.3%)
   LB compute        : 298.18 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0725795251964598e-17,-3.963114016646008e-17,1.3606303583824086e-17)
    sum a = (-2.9179783589405875e-17,1.0620410800799008e-17,9.676341759107254e-17)
    sum e = 2.5920009094280965
    sum de = -4.607859233063394e-19
Info: CFL hydro = 0.008714442863450255 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008714442863450255 cfl multiplier : 0.7732431495147735        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0140e+04 |  512 |      1 | 2.542e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 483.6479048084725 (tsim/hr)                             [sph::Model][rank=0]
Info: iteration since start : 1058                                                    [SPH][rank=0]
Info: time since start : 1770.3536881490002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14984289110236465 max=0.15018199483831068 delta=0.0003391037359460336
Number of particle pairs: 130816
Distance min=0.147231 max=1.993927 mean=0.805581
---------------- t = 8, dt = 0.008714442863450255 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.67 us    (1.6%)
   patch tree reduce : 1244.00 ns (0.2%)
   gen split merge   : 467.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 847.00 ns  (0.1%)
   LB compute        : 597.01 us  (96.3%)
   LB move op cnt    : 0
   LB apply          : 4.37 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.94 us    (74.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1097568176909878e-17,-3.929449539190333e-17,1.446694326834308e-17)
    sum a = (1.490370327150714e-16,-1.1129768981432697e-16,-2.727700877669381e-17)
    sum e = 2.592000997629801
    sum de = 9.622294280808852e-19
Info: CFL hydro = 0.009566400659962651 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009566400659962651 cfl multiplier : 0.8488287663431823        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5115e+04 |  512 |      1 | 3.387e-02 | 0.1% |   1.5% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 926.1371347558091 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.00871444286345, dt = 0.009566400659962651 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.4%)
   patch tree reduce : 1445.00 ns (0.5%)
   gen split merge   : 667.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 970.00 ns  (0.3%)
   LB compute        : 293.10 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1917.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.808383709923983e-18,-4.095356866129496e-17,1.3682414576332568e-17)
    sum a = (3.999925390907322e-17,-2.973012461215951e-17,3.3699605606063444e-17)
    sum e = 2.592001014250878
    sum de = 3.6591823321385775e-19
Info: CFL hydro = 0.010131058721769991 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010131058721769991 cfl multiplier : 0.8992191775621216        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9023e+04 |  512 |      1 | 2.692e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1279.5474874069573 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.018280843523414, dt = 0.010131058721769991 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.73 us    (1.6%)
   patch tree reduce : 1282.00 ns (0.4%)
   gen split merge   : 712.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1240.00 ns (0.4%)
   LB compute        : 285.50 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.922550198686706e-18,-4.0947896928680143e-17,1.440254165929744e-17)
    sum a = (-5.1123168198774496e-17,7.787910941137177e-17,6.674348573820765e-19)
    sum e = 2.592001024233032
    sum de = 2.2497195079074217e-18
Info: CFL hydro = 0.010506371186319006 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010506371186319006 cfl multiplier : 0.9328127850414143        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8783e+04 |  512 |      1 | 2.726e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1338.0168346358253 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.028411902245184, dt = 0.010506371186319006 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.3%)
   patch tree reduce : 1517.00 ns (0.5%)
   gen split merge   : 720.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 922.00 ns  (0.3%)
   LB compute        : 315.68 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (70.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.951512270484076e-18,-3.952538979706127e-17,1.42034821404291e-17)
    sum a = (3.817259008886964e-18,3.114696001116357e-17,-5.2557567672972814e-17)
    sum e = 2.5920010299902683
    sum de = 9.75781955236954e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010580393912261787
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.73196133055576e-18,-3.979095495481623e-17,1.3875619403469486e-17)
    sum a = (5.857033608114293e-17,-5.78092261560581e-17,2.4033509557486175e-17)
    sum e = 2.5920008931422083
    sum de = 4.0657581468206416e-19
Info: CFL hydro = 0.00537917592618367 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00537917592618367 cfl multiplier : 0.47760426168047143        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4465e+04 |  512 |      1 | 3.540e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1068.5373452848917 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.038918273431502, dt = 0.00537917592618367 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.5%)
   patch tree reduce : 1509.00 ns (0.5%)
   gen split merge   : 686.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 946.00 ns  (0.3%)
   LB compute        : 286.54 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1917.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.06599014610654e-18,-4.0526176164901174e-17,1.4440597155551682e-17)
    sum a = (-3.391037450839462e-17,4.716539658833341e-17,2.4203295617697406e-17)
    sum e = 2.592000928611245
    sum de = 2.439454888092385e-19
Info: CFL hydro = 0.007337568489206139 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007337568489206139 cfl multiplier : 0.6517361744536476        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0023e+04 |  512 |      1 | 2.557e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 757.3110437605834 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.044297449357686, dt = 0.007337568489206139 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.6%)
   patch tree reduce : 1561.00 ns (0.5%)
   gen split merge   : 682.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 896.00 ns  (0.3%)
   LB compute        : 279.78 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1872.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.679269104972964e-18,-3.9884081145169155e-17,1.466893013307713e-17)
    sum a = (-1.4016132005023607e-16,2.0468002293050346e-17,4.42263413391597e-17)
    sum e = 2.5920009584268935
    sum de = -2.710505431213761e-20
Info: CFL hydro = 0.008638714581281444 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008638714581281444 cfl multiplier : 0.7678241163024317        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9760e+04 |  512 |      1 | 2.591e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1019.4507599127722 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.051635017846891, dt = 0.008638714581281444 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 945.00 ns  (0.3%)
   gen split merge   : 661.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 819.00 ns  (0.3%)
   LB compute        : 276.36 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1959.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1194170590478337e-17,-3.973560982204263e-17,1.5122668742262313e-17)
    sum a = (5.256342236470424e-17,1.6845119049646583e-16,1.084757283997817e-16)
    sum e = 2.592000983344878
    sum de = 5.963111948670274e-19
Info: CFL hydro = 0.009503480432903142 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009503480432903142 cfl multiplier : 0.8452160775349545        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0010e+04 |  512 |      1 | 2.559e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1215.4418195778642 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.060273732428172, dt = 0.009503480432903142 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.3%)
   patch tree reduce : 1889.00 ns (0.6%)
   gen split merge   : 957.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 805.00 ns  (0.3%)
   LB compute        : 298.14 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.71 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.903211063699845e-18,-3.754064930010931e-17,1.6407773577309382e-17)
    sum a = (6.606434149736273e-17,8.80194354901942e-17,6.930784071657036e-17)
    sum e = 2.592001003239919
    sum de = 4.743384504624082e-20
Info: CFL hydro = 0.010078774518282653 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010078774518282653 cfl multiplier : 0.8968107183566364        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9787e+04 |  512 |      1 | 2.587e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1322.2266350127904 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.069777212861075, dt = 0.010078774518282653 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.65 us    (1.3%)
   patch tree reduce : 1145.00 ns (0.4%)
   gen split merge   : 647.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 764.00 ns  (0.3%)
   LB compute        : 269.03 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.69 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1909.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.19040234539925e-18,-3.698994235912245e-17,1.6902495028614517e-17)
    sum a = (7.561334371131156e-17,6.159135701455654e-17,-1.8131980292213078e-16)
    sum e = 2.5920010198446786
    sum de = -4.946672411965114e-19
Info: CFL hydro = 0.010462359780938658 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010462359780938658 cfl multiplier : 0.9312071455710909        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9514e+04 |  512 |      1 | 2.624e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1382.880386304479 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.079855987379357, dt = 0.010462359780938658 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.92 us    (1.4%)
   patch tree reduce : 1051.00 ns (0.4%)
   gen split merge   : 582.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 698.00 ns  (0.2%)
   LB compute        : 272.69 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.72 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1847.00 ns (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.23608759317751e-18,-3.652156702060871e-17,1.3743888839512497e-17)
    sum a = (-2.625243772369501e-17,-5.4518889402999095e-17,1.42034821404291e-17)
    sum e = 2.5920010349030465
    sum de = 9.75781955236954e-19
Info: CFL hydro = 0.010716671068718193 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010716671068718193 cfl multiplier : 0.9541380970473939        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0108e+04 |  512 |      1 | 2.546e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1479.2030729890234 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.090318347160295, dt = 0.010716671068718193 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.88 us    (1.2%)
   patch tree reduce : 1455.00 ns (0.4%)
   gen split merge   : 640.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 641.00 ns  (0.2%)
   LB compute        : 318.20 us  (95.5%)
   LB move op cnt    : 0
   LB apply          : 2.59 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.967192223138798e-18,-3.781325838385363e-17,1.4907508821132565e-17)
    sum a = (-8.644891443324032e-17,4.771573761108705e-17,-9.46235277632379e-17)
    sum e = 2.592001049508999
    sum de = -1.2569968937253817e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010316810798340023
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.403366757129716e-18,-3.7119477413680154e-17,1.4291302516400427e-17)
    sum a = (-2.7511050078657395e-16,-9.159079744636144e-17,1.488731013465916e-16)
    sum e = 2.592000900287384
    sum de = -5.89534931288993e-19
Info: CFL hydro = 0.005440793710141675 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005440793710141675 cfl multiplier : 0.484712699015798         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5042e+04 |  512 |      1 | 3.404e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1133.4197503564847 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.101035018229013, dt = 0.005440793710141675 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.5%)
   patch tree reduce : 1375.00 ns (0.5%)
   gen split merge   : 596.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 854.00 ns  (0.3%)
   LB compute        : 275.34 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2044564564467341e-17,-3.847996140476928e-17,1.649120293448214e-17)
    sum a = (-2.8365249602271823e-17,1.3676559884601148e-17,1.0328847152574205e-16)
    sum e = 2.5920009377984896
    sum de = -7.453889935837843e-20
Info: CFL hydro = 0.007366513243191361 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007366513243191361 cfl multiplier : 0.6564751326771986        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9703e+04 |  512 |      1 | 2.599e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 753.7548848578799 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.106475811939154, dt = 0.007366513243191361 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.4%)
   patch tree reduce : 1282.00 ns (0.4%)
   gen split merge   : 684.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 882.00 ns  (0.3%)
   LB compute        : 306.40 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1336878701431741e-17,-3.8108188479824e-17,1.7165956156528495e-17)
    sum a = (1.2531089447348487e-16,8.331226333813113e-17,3.184952301893418e-18)
    sum e = 2.5920009734610714
    sum de = -9.300421760852218e-19
Info: CFL hydro = 0.008648644732867083 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008648644732867083 cfl multiplier : 0.770983421784799         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9107e+04 |  512 |      1 | 2.680e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 989.6738399047154 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.113842325182345, dt = 0.008648644732867083 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.1%)
   patch tree reduce : 1320.00 ns (0.4%)
   gen split merge   : 933.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 869.00 ns  (0.2%)
   LB compute        : 332.48 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.809535995997099e-18,-3.721973900958075e-17,1.6848339130098864e-17)
    sum a = (-6.870480746823392e-17,1.2376818320225524e-17,-3.2552086026704786e-17)
    sum e = 2.5920010065950683
    sum de = 7.894347068410079e-19
Info: CFL hydro = 0.009502605711520557 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009502605711520557 cfl multiplier : 0.8473222811898659        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9614e+04 |  512 |      1 | 2.610e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1192.7726509584782 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.122490969915212, dt = 0.009502605711520557 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.4%)
   patch tree reduce : 1411.00 ns (0.4%)
   gen split merge   : 785.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 929.00 ns  (0.3%)
   LB compute        : 298.54 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1083663284047752e-17,-3.7417334855516235e-17,1.6347762987062308e-17)
    sum a = (-1.131126442510677e-16,1.399271323809792e-17,-4.964778588245622e-18)
    sum e = 2.5920010356914145
    sum de = -4.743384504624082e-19
Info: CFL hydro = 0.01007220207823937 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01007220207823937 cfl multiplier : 0.8982148541265772         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9952e+04 |  512 |      1 | 2.566e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1333.1260888682386 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.131993575626733, dt = 0.01007220207823937 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.71 us    (1.3%)
   patch tree reduce : 1428.00 ns (0.5%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 756.00 ns  (0.3%)
   LB compute        : 272.47 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.65 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1947.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.229192529011991e-17,-3.726218552463356e-17,1.641509194197366e-17)
    sum a = (6.37107554213312e-17,-1.8465697720904118e-17,-1.2169562232933195e-16)
    sum e = 2.5920010606292516
    sum de = -1.5720931501039814e-18
Info: CFL hydro = 0.010453291221944216 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010453291221944216 cfl multiplier : 0.9321432360843849        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9824e+04 |  512 |      1 | 2.583e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1403.9290143907554 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.142065777704973, dt = 0.010453291221944216 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.67 us    (1.3%)
   patch tree reduce : 1572.00 ns (0.5%)
   gen split merge   : 664.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 763.00 ns  (0.3%)
   LB compute        : 271.99 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.44 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0762387075285984e-17,-3.7613467028518866e-17,1.4549640789049413e-17)
    sum a = (-1.9004329360194915e-17,-1.0506829781209425e-16,-4.601787700897475e-18)
    sum e = 2.592001081505113
    sum de = -7.928228386300251e-19
Info: CFL hydro = 0.010709699419772192 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010709699419772192 cfl multiplier : 0.9547621573895899        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9666e+04 |  512 |      1 | 2.603e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1445.445223620064 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.152519068926917, dt = 0.010709699419772192 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.84 us    (1.3%)
   patch tree reduce : 1150.00 ns (0.4%)
   gen split merge   : 645.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1172.00 ns (0.4%)
   LB compute        : 287.75 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.43 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1428358259735205e-17,-3.897614652900727e-17,1.511095935879947e-17)
    sum a = (2.0608514894604467e-17,1.1024384530267106e-17,-1.2529040305242488e-18)
    sum e = 2.5920010983222523
    sum de = 4.811147140404426e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010620462679793751
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1178070188216926e-17,-3.851069853635925e-17,1.5121936905795884e-17)
    sum a = (-9.880377765947301e-17,4.934334191242229e-17,-5.157983415382539e-17)
    sum e = 2.5920009082962197
    sum de = 7.995991022080595e-19
Info: CFL hydro = 0.0054424545014854385 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0054424545014854385 cfl multiplier : 0.4849207191298633       [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5037e+04 |  512 |      1 | 3.405e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1132.3187517753151 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.16322876834669, dt = 0.0054424545014854385 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.3%)
   patch tree reduce : 1173.00 ns (0.4%)
   gen split merge   : 666.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 894.00 ns  (0.3%)
   LB compute        : 311.83 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 2.56 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.250269419245109e-17,-3.79735305700013e-17,1.4563545681911537e-17)
    sum a = (1.1810084160623902e-16,6.705963909170442e-17,-7.546697641802602e-17)
    sum e = 2.5920009564884574
    sum de = 1.5585406229479126e-18
Info: CFL hydro = 0.007371536211597818 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007371536211597818 cfl multiplier : 0.6566138127532422        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9557e+04 |  512 |      1 | 2.618e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 748.4056456433542 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.168671222848175, dt = 0.007371536211597818 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1619.00 ns (0.5%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 837.00 ns  (0.3%)
   LB compute        : 291.67 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.67 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1891.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1009747800938552e-17,-3.7494909520957575e-17,1.3988322219299353e-17)
    sum a = (3.107670371038651e-17,1.625350245018642e-16,-6.284426104508078e-17)
    sum e = 2.592000999279562
    sum de = -5.827586677109586e-19
Info: CFL hydro = 0.008660683267041043 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008660683267041043 cfl multiplier : 0.7710758751688281        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9715e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1021.8425644486733 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.176042759059774, dt = 0.008660683267041043 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.5%)
   patch tree reduce : 1094.00 ns (0.4%)
   gen split merge   : 716.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 775.00 ns  (0.3%)
   LB compute        : 268.85 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.73 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1945.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1134160000231264e-17,-3.561701714810406e-17,1.3540438301845591e-17)
    sum a = (-3.2786273695961654e-19,8.580892344334928e-17,3.143969459773466e-17)
    sum e = 2.5920010357838317
    sum de = -9.41900637346782e-19
Info: CFL hydro = 0.009524201538547397 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009524201538547397 cfl multiplier : 0.8473839167792189        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9791e+04 |  512 |      1 | 2.587e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1205.1626244507938 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.184703442326814, dt = 0.009524201538547397 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.4%)
   patch tree reduce : 1177.00 ns (0.4%)
   gen split merge   : 588.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 768.00 ns  (0.3%)
   LB compute        : 267.38 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.66 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1954.00 ns (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1422503568003783e-17,-3.5104731621604656e-17,1.4159571952443438e-17)
    sum a = (2.0917642618023534e-16,3.3384915925499523e-17,6.709476724209296e-17)
    sum e = 2.5920010632837527
    sum de = -1.2332799712022613e-18
Info: CFL hydro = 0.010103582553454199 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010103582553454199 cfl multiplier : 0.8982559445194793        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9816e+04 |  512 |      1 | 2.584e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1327.050847213245 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.19422764386536, dt = 0.010103582553454199 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.61 us    (1.3%)
   patch tree reduce : 1541.00 ns (0.5%)
   gen split merge   : 660.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 798.00 ns  (0.3%)
   LB compute        : 270.14 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.46 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.020927672047762e-18,-3.5050575723089004e-17,1.5043264485654907e-17)
    sum a = (-2.6205600189843637e-17,1.6258478938158127e-16,4.0502757397975487e-17)
    sum e = 2.5920010816589287
    sum de = -1.2197274440461925e-19
Info: CFL hydro = 0.010479281649999533 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010479281649999533 cfl multiplier : 0.9321706296796529        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0119e+04 |  512 |      1 | 2.545e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1429.245045918261 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.204331226418814, dt = 0.010479281649999533 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.45 us    (1.2%)
   patch tree reduce : 1152.00 ns (0.4%)
   gen split merge   : 944.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 825.00 ns  (0.3%)
   LB compute        : 270.61 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.54 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1959.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.628040552323025e-18,-3.262526967334756e-17,1.5309104082084773e-17)
    sum a = (1.4018473881716175e-16,-8.040248154761453e-17,-5.1638381071139605e-18)
    sum e = 2.5920010913107094
    sum de = 2.0328790734103208e-19
Info: CFL hydro = 0.010726672635906053 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010726672635906053 cfl multiplier : 0.9547804197864354        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9968e+04 |  512 |      1 | 2.564e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1471.3008777865418 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.214810508068814, dt = 0.010726672635906053 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.57 us    (1.3%)
   patch tree reduce : 1003.00 ns (0.4%)
   gen split merge   : 606.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 696.00 ns  (0.2%)
   LB compute        : 269.90 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 2.29 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1858.00 ns (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.157360641663058e-18,-3.4820779072630705e-17,1.5085711000707712e-17)
    sum a = (7.044365091246618e-17,-6.954788307755866e-17,-1.2091109363732145e-16)
    sum e = 2.5920010940506275
    sum de = 6.098637220230962e-19
Info: CFL hydro = 0.010890695247005954 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010890695247005954 cfl multiplier : 0.9698536131909569        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0347e+04 |  512 |      1 | 2.516e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1534.5841160245163 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.22553718070472, dt = 0.010890695247005954 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.75 us    (1.1%)
   patch tree reduce : 817.00 ns  (0.2%)
   gen split merge   : 577.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 675.00 ns  (0.2%)
   LB compute        : 323.81 us  (96.2%)
   LB move op cnt    : 0
   LB apply          : 2.40 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.809006483643465e-18,-3.5728256291001067e-17,1.3132622430928747e-17)
    sum a = (-2.2828613999159583e-16,-6.481143746683848e-17,1.4695276245868526e-17)
    sum e = 2.592001091502686
    sum de = -7.724940478959219e-19
Info: CFL hydro = 0.010999914630209719 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010999914630209719 cfl multiplier : 0.9799024087939712        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9794e+04 |  512 |      1 | 2.587e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1515.7111379572266 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.236427875951726, dt = 0.010999914630209719 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.79 us    (1.3%)
   patch tree reduce : 1237.00 ns (0.4%)
   gen split merge   : 659.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 844.00 ns  (0.3%)
   LB compute        : 274.28 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1983.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0974619650550021e-17,-3.612491165580489e-17,1.391664798536859e-17)
    sum a = (4.320762497789232e-17,-6.081853770600887e-17,-1.6106256953141163e-17)
    sum e = 2.592001085232622
    sum de = -2.710505431213761e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010167172580891016
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.469963875574638e-18,-3.631665281000895e-17,1.3731722058258137e-17)
    sum a = (6.341802083476011e-17,-1.3064159129494434e-16,4.255775419570451e-17)
    sum e = 2.59200090622494
    sum de = -1.0028870095490916e-18
Info: CFL hydro = 0.005537116752217334 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005537116752217334 cfl multiplier : 0.4933008029313237        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5097e+04 |  512 |      1 | 3.391e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1167.6170534493529 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.247427790581936, dt = 0.005537116752217334 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.08 us    (1.4%)
   patch tree reduce : 1053.00 ns (0.4%)
   gen split merge   : 673.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 804.00 ns  (0.3%)
   LB compute        : 269.82 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.57 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1993.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.869857973103912e-18,-3.7311950404350646e-17,1.433836874914756e-17)
    sum a = (6.61345977981398e-17,-2.0374327225347597e-18,-6.874725398328674e-17)
    sum e = 2.592000951439578
    sum de = -3.6591823321385775e-19
Info: CFL hydro = 0.007432669884397642 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007432669884397642 cfl multiplier : 0.6622005352875492        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9661e+04 |  512 |      1 | 2.604e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 765.4669121443675 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.252964907334153, dt = 0.007432669884397642 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.33 us    (1.1%)
   patch tree reduce : 1326.00 ns (0.5%)
   gen split merge   : 652.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 689.00 ns  (0.2%)
   LB compute        : 279.14 us  (95.6%)
   LB move op cnt    : 0
   LB apply          : 2.63 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1917.00 ns (64.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.541995236144295e-18,-3.700384725198458e-17,1.3565778139495652e-17)
    sum a = (-2.1545265571631944e-17,4.8898385340834236e-17,1.3101190054695677e-16)
    sum e = 2.592000983484558
    sum de = -2.303929616531697e-19
Info: CFL hydro = 0.008696739976669539 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008696739976669539 cfl multiplier : 0.7748003568583662        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0167e+04 |  512 |      1 | 2.539e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1053.9636424071966 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.260397577218551, dt = 0.008696739976669539 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.39 us    (1.1%)
   patch tree reduce : 1402.00 ns (0.5%)
   gen split merge   : 657.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 710.00 ns  (0.2%)
   LB compute        : 294.94 us  (95.7%)
   LB move op cnt    : 0
   LB apply          : 2.42 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.33 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.051353416777985e-18,-3.6373004217923885e-17,1.5353060009849588e-17)
    sum a = (-3.5268662990084464e-17,9.906138409565556e-17,6.296062304324279e-17)
    sum e = 2.5920010067506083
    sum de = 4.0657581468206416e-20
Info: CFL hydro = 0.00954056949522783 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00954056949522783 cfl multiplier : 0.8498669045722442         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9878e+04 |  512 |      1 | 2.576e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1215.548543920788 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.26909431719522, dt = 0.00954056949522783 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.23 us    (1.1%)
   patch tree reduce : 803.00 ns  (0.3%)
   gen split merge   : 634.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 665.00 ns  (0.2%)
   LB compute        : 286.74 us  (96.0%)
   LB move op cnt    : 0
   LB apply          : 2.05 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.467036529708927e-18,-3.481858356323142e-17,1.5685679683840986e-17)
    sum a = (4.784454082917833e-17,-1.6060590357636073e-16,-2.3682228053600874e-17)
    sum e = 2.592001020995975
    sum de = -9.0801931945661e-19
Info: CFL hydro = 0.010105004001259039 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010105004001259039 cfl multiplier : 0.8999112697148295        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9735e+04 |  512 |      1 | 2.594e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1323.8656551922888 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.278634886690448, dt = 0.010105004001259039 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.95 us    (1.4%)
   patch tree reduce : 912.00 ns  (0.3%)
   gen split merge   : 653.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 499.00 ns  (0.2%)
   LB compute        : 271.54 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.46 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1919.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.4893030105615e-18,-3.792230201735136e-17,1.5072629423870317e-17)
    sum a = (-1.6557068216460634e-17,-2.030407092457054e-16,-5.971200096877016e-17)
    sum e = 2.592001028652907
    sum de = 1.5585406229479126e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010158964776431027
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.79374698059543e-18,-3.833286227501731e-17,1.486515378563806e-17)
    sum a = (9.690685753849237e-17,5.125197141686577e-17,-1.225445526303881e-16)
    sum e = 2.5920009064006426
    sum de = -4.0657581468206416e-19
Info: CFL hydro = 0.005236533745635114 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005236533745635114 cfl multiplier : 0.4666370899049432        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4828e+04 |  512 |      1 | 3.453e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1053.5573578181074 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.288739890691707, dt = 0.005236533745635114 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.69 us    (1.5%)
   patch tree reduce : 916.00 ns  (0.3%)
   gen split merge   : 644.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 674.00 ns  (0.2%)
   LB compute        : 291.83 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.27 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.728193085476676e-18,-3.6629878817640016e-17,1.3866471447639139e-17)
    sum a = (-7.306655280814311e-17,-7.13101452887166e-18,-7.491663539527238e-17)
    sum e = 2.592000938979596
    sum de = 2.303929616531697e-19
Info: CFL hydro = 0.007228163875794711 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007228163875794711 cfl multiplier : 0.6444247266032955        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0243e+04 |  512 |      1 | 2.529e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 745.3232854316836 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.293976424437341, dt = 0.007228163875794711 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.3%)
   patch tree reduce : 1438.00 ns (0.5%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 707.00 ns  (0.2%)
   LB compute        : 301.19 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.48 us    (70.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.787892288864008e-18,-3.705910090519987e-17,1.3409622533471638e-17)
    sum a = (1.5086369653527498e-16,-7.786740002790893e-17,3.1468968056391766e-17)
    sum e = 2.5920009665401595
    sum de = -9.351243737687476e-19
Info: CFL hydro = 0.008553175792989063 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008553175792989063 cfl multiplier : 0.7629498177355304        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0449e+04 |  512 |      1 | 2.504e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1039.276230811998 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.301204588313135, dt = 0.008553175792989063 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.3%)
   patch tree reduce : 995.00 ns  (0.3%)
   gen split merge   : 638.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 696.00 ns  (0.2%)
   LB compute        : 298.28 us  (95.6%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.5396906639980654e-18,-3.7928522627315995e-17,1.4101025035129222e-17)
    sum a = (2.1505453667858277e-16,-1.1547793971056208e-16,-4.876958212274296e-18)
    sum e = 2.5920009888155224
    sum de = 7.589415207398531e-19
Info: CFL hydro = 0.00943521468923774 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00943521468923774 cfl multiplier : 0.8419665451570202         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0184e+04 |  512 |      1 | 2.537e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1213.826685708048 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.309757764106124, dt = 0.00943521468923774 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.71 us    (1.2%)
   patch tree reduce : 859.00 ns  (0.3%)
   gen split merge   : 653.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 785.00 ns  (0.3%)
   LB compute        : 296.55 us  (95.6%)
   LB move op cnt    : 0
   LB apply          : 2.47 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.268070272206437e-18,-3.92172866446952e-17,1.390635653505945e-17)
    sum a = (-7.735218715554381e-17,-7.953013247963269e-17,-4.3757966000645965e-17)
    sum e = 2.592001005774956
    sum de = 2.710505431213761e-19
Info: CFL hydro = 0.010023726760180401 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010023726760180401 cfl multiplier : 0.8946443634380135        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0533e+04 |  512 |      1 | 2.494e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1362.1737723493063 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.31919297879536, dt = 0.010023726760180401 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.80 us    (1.3%)
   patch tree reduce : 1071.00 ns (0.4%)
   gen split merge   : 597.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 565.00 ns  (0.2%)
   LB compute        : 286.82 us  (95.6%)
   LB move op cnt    : 0
   LB apply          : 2.66 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1930.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.475289054952426e-18,-3.972838293693666e-17,1.3264901872235558e-17)
    sum a = (6.768023641523513e-18,4.469471667767344e-17,-5.175547490576804e-18)
    sum e = 2.5920010194062
    sum de = 2.710505431213761e-20
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010321579466155539
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.083024708947171e-18,-3.915855676826438e-17,1.3482989139231017e-17)
    sum a = (-8.96938773253808e-18,1.3848687821504946e-16,2.2353213030568142e-17)
    sum e = 2.5920009086105513
    sum de = -2.303929616531697e-19
Info: CFL hydro = 0.005209960178635605 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005209960178635605 cfl multiplier : 0.4648814544793378        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4730e+04 |  512 |      1 | 3.476e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1038.1632681747592 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.329216705555542, dt = 0.005209960178635605 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.08 us    (1.3%)
   patch tree reduce : 1661.00 ns (0.5%)
   gen split merge   : 639.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 847.00 ns  (0.3%)
   LB compute        : 303.85 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.74 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.200118543575606e-18,-3.8034455955831406e-17,1.3810120039724205e-17)
    sum a = (-7.088860748405423e-17,-2.044458352612466e-17,-2.5760643618255583e-18)
    sum e = 2.592000938055065
    sum de = -4.87890977618477e-19
Info: CFL hydro = 0.007210026690247802 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007210026690247802 cfl multiplier : 0.6432543029862252        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0308e+04 |  512 |      1 | 2.521e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 743.9288438714874 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.334426665734178, dt = 0.007210026690247802 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.50 us    (1.2%)
   patch tree reduce : 1072.00 ns (0.4%)
   gen split merge   : 685.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 757.00 ns  (0.3%)
   LB compute        : 269.07 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 2.01 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (64.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.855844017494839e-18,-3.875943145538636e-17,1.3644359080078327e-17)
    sum a = (2.782149510771603e-17,-9.026763711506014e-17,5.391000146293123e-17)
    sum e = 2.5920009668898265
    sum de = 1.0570971181733668e-18
Info: CFL hydro = 0.008544870400868362 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008544870400868362 cfl multiplier : 0.7621695353241501        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8849e+04 |  512 |      1 | 2.716e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 955.5429397227914 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.341636692424425, dt = 0.008544870400868362 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.78 us    (1.7%)
   patch tree reduce : 1396.00 ns (0.5%)
   gen split merge   : 819.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 754.00 ns  (0.3%)
   LB compute        : 269.75 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.55 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.223537310501293e-18,-3.948074777260918e-17,1.4352776779580356e-17)
    sum a = (3.626396058442616e-17,1.3209355484433693e-16,5.2188722093893247e-17)
    sum e = 2.592000993482717
    sum de = -7.657177843178875e-19
Info: CFL hydro = 0.00943813972120022 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00943813972120022 cfl multiplier : 0.8414463568827667         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0400e+04 |  512 |      1 | 2.510e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1225.644115120738 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.350181562825293, dt = 0.00943813972120022 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.97 us    (1.3%)
   patch tree reduce : 1341.00 ns (0.4%)
   gen split merge   : 591.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 777.00 ns  (0.3%)
   LB compute        : 288.37 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.78 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.39 us    (70.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.030332483364375e-18,-3.73661063028663e-17,1.4783096621839852e-17)
    sum a = (1.6580486983386322e-17,-1.4051260155412136e-18,4.847684753617187e-18)
    sum e = 2.592001017154558
    sum de = 2.507217523872729e-19
Info: CFL hydro = 0.010030223947118885 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010030223947118885 cfl multiplier : 0.8942975712551778        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0361e+04 |  512 |      1 | 2.515e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1351.226522169163 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.359619702546492, dt = 0.010030223947118885 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.5%)
   patch tree reduce : 1972.00 ns (0.7%)
   gen split merge   : 635.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 859.00 ns  (0.3%)
   LB compute        : 267.40 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.71 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1945.00 ns (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.819563581033194e-18,-3.7950477721308825e-17,1.4583305266505087e-17)
    sum a = (-7.183706754454456e-17,6.95069002354387e-17,-9.992787847190599e-17)
    sum e = 2.592001038350543
    sum de = 3.5236570605778894e-19
Info: CFL hydro = 0.010425193070613072 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010425193070613072 cfl multiplier : 0.9295317141701185        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0349e+04 |  512 |      1 | 2.516e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1435.1461874336649 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.369649926493612, dt = 0.010425193070613072 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.5%)
   patch tree reduce : 1587.00 ns (0.5%)
   gen split merge   : 762.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 885.00 ns  (0.3%)
   LB compute        : 273.64 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.867553400957682e-18,-3.7002749497284936e-17,1.3058889906936156e-17)
    sum a = (2.027187012004772e-17,-3.8020368103852674e-17,-2.0737318112695746e-17)
    sum e = 2.5920010577152284
    sum de = -1.7957098481791167e-19
Info: CFL hydro = 0.010684569073972463 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010684569073972463 cfl multiplier : 0.953021142780079         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9753e+04 |  512 |      1 | 2.592e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1447.9706873430475 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.380075119564225, dt = 0.010684569073972463 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.4%)
   patch tree reduce : 1359.00 ns (0.4%)
   gen split merge   : 659.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1120.00 ns (0.3%)
   LB compute        : 308.02 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.287938919546932e-18,-3.794791629367633e-17,1.326234044460306e-17)
    sum a = (-3.06090602083392e-17,-3.7481736464561873e-17,5.003419553673005e-17)
    sum e = 2.592001075297754
    sum de = 9.046311876675928e-19
Info: CFL hydro = 0.010847893385164554 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010847893385164554 cfl multiplier : 0.968680761853386         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0292e+04 |  512 |      1 | 2.523e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1524.4661464700985 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.390759688638198, dt = 0.010847893385164554 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.5%)
   patch tree reduce : 1312.00 ns (0.4%)
   gen split merge   : 933.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 962.00 ns  (0.3%)
   LB compute        : 275.88 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.33 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.902681551346212e-18,-3.852167608335566e-17,1.4171281335906282e-17)
    sum a = (-8.851122959563362e-17,-5.65680315089967e-17,5.0865561762591936e-17)
    sum e = 2.5920010907101116
    sum de = -1.2104100816263952e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010017720200251028
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.090031686751708e-18,-3.8552413214945627e-17,1.4193236429899115e-17)
    sum a = (2.0605587548738757e-17,-1.5896658989156266e-16,6.395665247405091e-17)
    sum e = 2.59200092047746
    sum de = 5.929230630780102e-19
Info: CFL hydro = 0.0054784706079113775 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0054784706079113775 cfl multiplier : 0.48956025395112873      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4650e+04 |  512 |      1 | 3.495e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1117.38683357378 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 8.401607582023363, dt = 0.0054784706079113775 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.89 us    (1.5%)
   patch tree reduce : 1183.00 ns (0.4%)
   gen split merge   : 641.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1391.00 ns (0.4%)
   LB compute        : 299.08 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.43 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.5572547391923305e-18,-3.993704780942686e-17,1.4644047693218587e-17)
    sum a = (6.009841062304399e-17,1.8254928818572934e-17,-6.814861175374887e-18)
    sum e = 2.592000962863672
    sum de = -1.6191034786765951e-18
Info: CFL hydro = 0.007379881501211747 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007379881501211747 cfl multiplier : 0.6597068359674192        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0094e+04 |  512 |      1 | 2.548e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 774.0499900246112 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.407086052631275, dt = 0.007379881501211747 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1245.00 ns (0.4%)
   gen split merge   : 579.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 879.00 ns  (0.3%)
   LB compute        : 290.64 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (70.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.895674573541676e-18,-3.93149868129633e-17,1.4382050238237466e-17)
    sum a = (1.7043007630168637e-17,3.8014513412121255e-17,2.103005269926683e-17)
    sum e = 2.592001001378756
    sum de = 5.251604272976662e-20
Info: CFL hydro = 0.008645827920304919 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008645827920304919 cfl multiplier : 0.7731378906449461        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0200e+04 |  512 |      1 | 2.535e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1048.172787649885 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.414465934132487, dt = 0.008645827920304919 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.5%)
   patch tree reduce : 1273.00 ns (0.4%)
   gen split merge   : 626.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1207.00 ns (0.4%)
   LB compute        : 290.44 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.39 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.837127656227459e-18,-3.8865639222576684e-17,1.4559154663112973e-17)
    sum a = (1.3699978651526834e-17,8.86400328137249e-18,1.9250226412914628e-17)
    sum e = 2.592001035387675
    sum de = -7.792703114739563e-20
Info: CFL hydro = 0.009489414675409197 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009489414675409197 cfl multiplier : 0.8487585937632973        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0123e+04 |  512 |      1 | 2.544e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1223.3006560117553 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.423111762052791, dt = 0.009489414675409197 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.99 us    (1.4%)
   patch tree reduce : 1490.00 ns (0.5%)
   gen split merge   : 788.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 806.00 ns  (0.3%)
   LB compute        : 265.84 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.761016663718977e-18,-3.896882816434299e-17,1.4822615791026948e-17)
    sum a = (-1.4696447184214812e-16,6.042041866827219e-18,1.0693008978268636e-16)
    sum e = 2.59200106252008
    sum de = 2.168404344971009e-19
Info: CFL hydro = 0.010052919176660397 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010052919176660397 cfl multiplier : 0.8991723958421982        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7112e+04 |  512 |      1 | 2.992e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1141.7217189283365 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.4326011767282, dt = 0.010052919176660397 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.5%)
   patch tree reduce : 1521.00 ns (0.5%)
   gen split merge   : 821.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 778.00 ns  (0.3%)
   LB compute        : 291.04 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.143876198407618e-18,-3.883636576391958e-17,1.6265797302822404e-17)
    sum a = (1.0317137769111362e-16,3.499202880577479e-17,2.839525489739536e-17)
    sum e = 2.5920010824224127
    sum de = 3.1848438816761693e-19
Info: CFL hydro = 0.010431141303172367 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010431141303172367 cfl multiplier : 0.9327815972281321        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9222e+04 |  512 |      1 | 2.664e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1358.6713543351698 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.44265409590486, dt = 0.010431141303172367 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.5%)
   patch tree reduce : 1616.00 ns (0.6%)
   gen split merge   : 806.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 748.00 ns  (0.3%)
   LB compute        : 269.15 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.79 us    (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.743452588524711e-18,-3.83775042994694e-17,1.6296534434412368e-17)
    sum a = (7.803133139638874e-17,1.969993992153446e-17,-5.326598537247484e-17)
    sum e = 2.592001095522017
    sum de = -7.792703114739563e-19
Info: CFL hydro = 0.010687159152359179 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010687159152359179 cfl multiplier : 0.9551877314854215        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9415e+04 |  512 |      1 | 2.637e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1423.9760164871814 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.453085237208033, dt = 0.010687159152359179 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.3%)
   patch tree reduce : 1506.00 ns (0.5%)
   gen split merge   : 812.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 944.00 ns  (0.3%)
   LB compute        : 309.15 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.43 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.35 us    (69.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.882812904005718e-18,-3.818137212646677e-17,1.525732665208501e-17)
    sum a = (-3.529208175701015e-17,2.2830370406679013e-17,6.499878760224398e-17)
    sum e = 2.592001102581242
    sum de = 2.0735366548785272e-18
Info: CFL hydro = 0.010862891709625793 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010862891709625793 cfl multiplier : 0.9701251543236143        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9066e+04 |  512 |      1 | 2.685e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1432.7207491278664 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.463772396360392, dt = 0.010862891709625793 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.4%)
   patch tree reduce : 1508.00 ns (0.5%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 944.00 ns  (0.3%)
   LB compute        : 293.36 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.948366799124471e-18,-3.7959625677139174e-17,1.6656597975894804e-17)
    sum a = (-1.1981041159181416e-16,1.107122206411848e-17,-3.722413002837932e-17)
    sum e = 2.5920011045470592
    sum de = 2.4801124695605914e-18
Info: CFL hydro = 0.010986158648760543 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010986158648760543 cfl multiplier : 0.9800834362157428        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9733e+04 |  512 |      1 | 2.595e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1507.2039149526292 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.474635288070019, dt = 0.010986158648760543 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.4%)
   patch tree reduce : 1406.00 ns (0.5%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 857.00 ns  (0.3%)
   LB compute        : 294.13 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.687210243356724e-18,-3.788790570342926e-17,1.5673009765015954e-17)
    sum a = (-1.399271323809792e-16,3.454268121538817e-19,4.7733301686281315e-17)
    sum e = 2.5920011024489664
    sum de = -2.0735366548785272e-18
Info: CFL hydro = 0.011068460643638556 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011068460643638556 cfl multiplier : 0.9867222908104951        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9704e+04 |  512 |      1 | 2.598e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1522.0826347416553 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.48562144671878, dt = 0.011068460643638556 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 1454.00 ns (0.5%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 845.00 ns  (0.3%)
   LB compute        : 275.63 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1977.00 ns (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.267977010840589e-18,-3.801524524858768e-17,1.6653670630029095e-17)
    sum a = (1.1522033327437953e-17,1.0595821095527036e-16,4.6708730633282515e-17)
    sum e = 2.5920010971415053
    sum de = 2.710505431213761e-20
Info: CFL hydro = 0.011110679001402704 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011110679001402704 cfl multiplier : 0.9911481938736634        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9693e+04 |  512 |      1 | 2.600e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1532.61155786826 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 8.496689907362418, dt = 0.003310092637581974 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.4%)
   patch tree reduce : 1509.00 ns (0.5%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 902.00 ns  (0.3%)
   LB compute        : 271.45 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.266824724767475e-18,-3.7134845979475136e-17,1.6820529344374612e-17)
    sum a = (5.709495376482465e-17,-4.153903783443713e-17,-6.544374417383203e-17)
    sum e = 2.59200093587518
    sum de = 1.3417001884508117e-18
Info: CFL hydro = 0.011142595918146116 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011142595918146116 cfl multiplier : 0.9940987959157755        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7537e+04 |  512 |      1 | 2.920e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 408.14721711893003 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 1114                                                    [SPH][rank=0]
Info: time since start : 1772.5087054070002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.1498247238771645 max=0.15018225331739038 delta=0.00035752944022587885
Number of particle pairs: 130816
Distance min=0.146874 max=1.992698 mean=0.805308
---------------- t = 8.5, dt = 0.011142595918146116 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.05 us    (1.2%)
   patch tree reduce : 1579.00 ns (0.2%)
   gen split merge   : 501.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 845.00 ns  (0.1%)
   LB compute        : 728.82 us  (96.7%)
   LB move op cnt    : 0
   LB apply          : 5.88 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.39 us    (81.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.67550085989388e-18,-3.770128740449019e-17,1.5971599043318464e-17)
    sum a = (-1.5060609009909243e-16,-1.3969294471172233e-17,1.0442428172163787e-16)
    sum e = 2.592001089830599
    sum de = -1.2468324983583301e-18
Info: CFL hydro = 0.011158720641268398 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011158720641268398 cfl multiplier : 0.9960658639438504        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.2242e+04 |  512 |      1 | 4.182e-02 | 0.1% |   1.4% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 959.1144390473595 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.511142595918146, dt = 0.011158720641268398 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.5%)
   patch tree reduce : 1318.00 ns (0.4%)
   gen split merge   : 739.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 291.41 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (70.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0719940560233176e-17,-3.784180000604431e-17,1.803245053277891e-17)
    sum a = (3.57370383285982e-17,6.965912222045567e-17,-5.882208782559406e-17)
    sum e = 2.5920010799919018
    sum de = -8.538092108323347e-19
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.010203075411600804
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.589985056068784e-18,-3.72182753366479e-17,1.711911862267712e-17)
    sum a = (2.7207923414263034e-16,-9.506848433482595e-17,7.262452358242077e-17)
    sum e = 2.592000920834401
    sum de = -7.453889935837843e-19
Info: CFL hydro = 0.0055854933601947295 sink sink = inf                               [SPH][rank=0]
Info: cfl dt = 0.0055854933601947295 cfl multiplier : 0.49868862131461683      [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4061e+04 |  512 |      1 | 3.641e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1103.195308129749 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.522301316559414, dt = 0.0055854933601947295 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.6%)
   patch tree reduce : 1370.00 ns (0.5%)
   gen split merge   : 730.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 938.00 ns  (0.3%)
   LB compute        : 276.08 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.45 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1975.00 ns (64.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.773878333254935e-18,-3.8799773940598194e-17,1.8254928818572934e-17)
    sum a = (1.4538370507466424e-16,-1.297399687683054e-17,-7.342368900375983e-17)
    sum e = 2.5920009604982295
    sum de = 4.472333961502706e-19
Info: CFL hydro = 0.007456335979743657 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007456335979743657 cfl multiplier : 0.6657924142097446        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8853e+04 |  512 |      1 | 2.716e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 740.4072084938564 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.52788680991961, dt = 0.007456335979743657 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.5%)
   patch tree reduce : 1044.00 ns (0.4%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 912.00 ns  (0.3%)
   LB compute        : 272.43 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.153281009724232e-18,-3.864974746498051e-17,1.7300614066351194e-17)
    sum a = (-9.6860020004641e-17,-4.200155848121945e-17,1.4557690990180115e-17)
    sum e = 2.5920009885425666
    sum de = 7.047314121155779e-19
Info: CFL hydro = 0.008702632342196532 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008702632342196532 cfl multiplier : 0.7771949428064963        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8540e+04 |  512 |      1 | 2.762e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 971.9779737168731 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.535343145899352, dt = 0.008702632342196532 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.6%)
   patch tree reduce : 1376.00 ns (0.5%)
   gen split merge   : 686.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 933.00 ns  (0.3%)
   LB compute        : 276.10 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1816.00 ns (64.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.818940807313713e-18,-3.907933547077358e-17,1.7654822916102207e-17)
    sum a = (2.210731597784843e-17,-7.2926040206589e-17,-7.062221901027455e-17)
    sum e = 2.5920010098459967
    sum de = -2.6969529040576923e-18
Info: CFL hydro = 0.009530616523797695 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.009530616523797695 cfl multiplier : 0.8514632952043307        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9129e+04 |  512 |      1 | 2.677e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1170.486000481036 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.544045778241548, dt = 0.009530616523797695 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.86 us    (1.6%)
   patch tree reduce : 1501.00 ns (0.5%)
   gen split merge   : 713.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 291.52 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.40 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1975.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.207125521380143e-18,-3.9954245966387914e-17,1.6662452667626226e-17)
    sum a = (-2.32314167902814e-17,-3.4179690328040025e-17,9.815976156901663e-17)
    sum e = 2.5920010245880585
    sum de = -7.589415207398531e-19
Info: CFL hydro = 0.010082343031148189 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010082343031148189 cfl multiplier : 0.9009755301362204        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7972e+04 |  512 |      1 | 2.849e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1204.3409310345896 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.553576394765345, dt = 0.010082343031148189 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 1469.00 ns (0.5%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 870.00 ns  (0.3%)
   LB compute        : 305.75 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.684282897491013e-18,-4.011049305197023e-17,1.8421787532918455e-17)
    sum a = (-4.191959279697954e-17,-5.940170230700481e-17,-4.088916705224932e-17)
    sum e = 2.5920010350289058
    sum de = 1.0570971181733668e-18
Info: CFL hydro = 0.010451057885542648 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010451057885542648 cfl multiplier : 0.9339836867574803        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8384e+04 |  512 |      1 | 2.785e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1303.247088397681 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.563658737796494, dt = 0.010451057885542648 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.5%)
   patch tree reduce : 1679.00 ns (0.6%)
   gen split merge   : 1039.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 896.00 ns  (0.3%)
   LB compute        : 272.96 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1832.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.21705984505039e-18,-4.055805679096993e-17,1.7239139803171265e-17)
    sum a = (-3.320781150062402e-17,-2.4496030204268494e-17,-2.7798076340790345e-17)
    sum e = 2.5920010434656646
    sum de = -6.098637220230962e-19
Info: CFL hydro = 0.010698857291995316 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010698857291995316 cfl multiplier : 0.9559891245049869        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9078e+04 |  512 |      1 | 2.684e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1401.9563243499533 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.574109795682038, dt = 0.010698857291995316 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.66 us    (1.6%)
   patch tree reduce : 1552.00 ns (0.5%)
   gen split merge   : 763.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 910.00 ns  (0.3%)
   LB compute        : 273.85 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.52443116095003e-18,-4.119818500019842e-17,1.7110336585079988e-17)
    sum a = (-4.2235746150476315e-17,2.8219614145452706e-17,-8.420217648130724e-17)
    sum e = 2.592001051644943
    sum de = -1.0299920638612292e-18
Warning: the corrector tolerance are broken the step will be re rerunned      [BasicGasSPH][rank=0]
    eps_v = 0.01032975061139799
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.702999258758393e-18,-4.064162336748014e-17,1.6867366878225988e-17)
    sum a = (2.237194804410869e-16,-7.205954583033857e-17,3.4144562177651494e-17)
    sum e = 2.5920009245652187
    sum de = -2.574980159653073e-19
Info: CFL hydro = 0.005434104060206059 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.005434104060206059 cfl multiplier : 0.485329708168329         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4149e+04 |  512 |      1 | 3.619e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1064.3842228140895 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.584808652974033, dt = 0.005434104060206059 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.5%)
   patch tree reduce : 1256.00 ns (0.4%)
   gen split merge   : 683.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 911.00 ns  (0.3%)
   LB compute        : 277.02 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.8751831524817e-18,-4.158807087768779e-17,1.7643113532639363e-17)
    sum a = (-1.0018548490808854e-16,7.072467611557442e-18,-6.868724339303967e-17)
    sum e = 2.5920009566664697
    sum de = -2.574980159653073e-19
Info: CFL hydro = 0.007356773052897603 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.007356773052897603 cfl multiplier : 0.6568864721122193        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8763e+04 |  512 |      1 | 2.729e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 716.9142223026186 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.59024275703424, dt = 0.007356773052897603 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.92 us    (1.2%)
   patch tree reduce : 1311.00 ns (0.4%)
   gen split merge   : 742.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 943.00 ns  (0.3%)
   LB compute        : 316.95 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.488150724488385e-18,-4.140437992461443e-17,1.681467465264319e-17)
    sum a = (4.275095902284143e-17,-1.234637392322213e-16,5.4354958034519286e-17)
    sum e = 2.592000985855972
    sum de = 6.776263578034403e-20
Info: CFL hydro = 0.008641394557923116 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.008641394557923116 cfl multiplier : 0.7712576480748128        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7280e+04 |  512 |      1 | 2.963e-02 | 0.0% |   1.5% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 893.8639037443381 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.597599530087138, dt = 0.008641394557923116 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 1770.00 ns (0.6%)
   gen split merge   : 733.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 285.32 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.71 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.876335438554815e-18,-4.301551790545505e-17,1.7774844096596353e-17)
    sum a = (9.184840388254401e-17,7.369885951513666e-17,6.052580311943778e-17)
    sum e = 2.5920010126257025
    sum de = -2.710505431213761e-19
Info: CFL hydro = 0.00950174997057878 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.00950174997057878 cfl multiplier : 0.8475050987165419         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9487e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1184.0310255783575 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.60624092464506, dt = 0.00950174997057878 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.4%)
   patch tree reduce : 1388.00 ns (0.5%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 739.00 ns  (0.3%)
   LB compute        : 268.02 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1961.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.684905671210494e-18,-4.11156704386087e-17,1.8354458578007104e-17)
    sum a = (1.422690090735479e-17,1.938020056935219e-16,-1.263442475640808e-17)
    sum e = 2.5920010363395756
    sum de = -1.3688052427629493e-18
Info: CFL hydro = 0.010080255006589092 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010080255006589092 cfl multiplier : 0.8983367324776946        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9433e+04 |  512 |      1 | 2.635e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1298.3146915542272 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.615742674615639, dt = 0.010080255006589092 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.4%)
   patch tree reduce : 1237.00 ns (0.4%)
   gen split merge   : 716.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 794.00 ns  (0.3%)
   LB compute        : 271.90 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.892747227675965e-18,-3.8901499209431644e-17,1.784070937857485e-17)
    sum a = (2.238248648922525e-17,-1.9751388025124327e-16,-1.1716409092921153e-16)
    sum e = 2.5920010574906462
    sum de = -5.759824041329242e-19
Info: CFL hydro = 0.010469562485233614 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010469562485233614 cfl multiplier : 0.932224488318463         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8524e+04 |  512 |      1 | 2.764e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1312.911387804297 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.625822929622228, dt = 0.010469562485233614 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.66 us    (1.6%)
   patch tree reduce : 1200.00 ns (0.4%)
   gen split merge   : 1038.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 822.00 ns  (0.3%)
   LB compute        : 275.63 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.57 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.597085295239168e-18,-4.2950750378176196e-17,1.6106256953141163e-17)
    sum a = (4.863492421292026e-17,-6.845305572378279e-17,4.402728182029136e-18)
    sum e = 2.592001076460368
    sum de = 4.743384504624082e-20
Info: CFL hydro = 0.010720088768950507 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010720088768950507 cfl multiplier : 0.9548163255456421        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8005e+04 |  512 |      1 | 2.844e-02 | 0.0% |   1.5% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1325.4210660112738 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.636292492107462, dt = 0.010720088768950507 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.79 us    (1.3%)
   patch tree reduce : 2.05 us    (0.7%)
   gen split merge   : 668.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 785.00 ns  (0.3%)
   LB compute        : 277.17 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1939.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.087727114605478e-18,-4.2860002656339155e-17,1.6826384036106034e-17)
    sum a = (1.1402743983410235e-16,3.9741647472890664e-17,-5.0970946213757525e-17)
    sum e = 2.592001092952547
    sum de = 7.521652571618187e-19
Info: CFL hydro = 0.010886811209497051 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010886811209497051 cfl multiplier : 0.9698775503637614        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9210e+04 |  512 |      1 | 2.665e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1447.9710645392645 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.647012580876412, dt = 0.010886811209497051 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (0.7%)
   patch tree reduce : 1527.00 ns (0.3%)
   gen split merge   : 683.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 986.00 ns  (0.2%)
   LB compute        : 550.89 us  (97.1%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (0.5%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.43084935461313e-18,-4.194374340037166e-17,1.599209046437844e-17)
    sum a = (4.547997720615038e-17,5.595328887719741e-17,-5.292641325205239e-18)
    sum e = 2.592001107089191
    sum de = 4.743384504624082e-20
Info: CFL hydro = 0.010984472818408579 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.010984472818408579 cfl multiplier : 0.9799183669091743        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7119e+04 |  512 |      1 | 2.991e-02 | 0.0% |   1.5% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1310.4393893948898 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.657899392085909, dt = 0.010984472818408579 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.4%)
   patch tree reduce : 1164.00 ns (0.4%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 931.00 ns  (0.3%)
   LB compute        : 305.05 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.53 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.47 us    (70.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.454268121538817e-18,-4.116214205422686e-17,1.6233596498299585e-17)
    sum a = (-9.204453605554663e-17,1.2646134139870925e-16,-3.264576109440753e-17)
    sum e = 2.5920011181152214
    sum de = 1.353558649712372e-18
Info: CFL hydro = 0.011046609439702053 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011046609439702053 cfl multiplier : 0.9866122446061162        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8868e+04 |  512 |      1 | 2.714e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1457.283511234582 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.668883864904318, dt = 0.011046609439702053 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.4%)
   patch tree reduce : 1306.00 ns (0.4%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 863.00 ns  (0.3%)
   LB compute        : 288.00 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.2311670620253106e-18,-3.942768962879317e-17,1.5604948973638178e-17)
    sum a = (-1.303371473249104e-16,-6.888044822017658e-17,3.388695574146894e-17)
    sum e = 2.592001126140071
    sum de = -4.319868030996932e-20
Info: CFL hydro = 0.011086142378147736 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011086142378147736 cfl multiplier : 0.9910748297374109        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9098e+04 |  512 |      1 | 2.681e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1483.3689518142207 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.67993047434402, dt = 0.011086142378147736 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.5%)
   patch tree reduce : 1492.00 ns (0.5%)
   gen split merge   : 1027.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 882.00 ns  (0.3%)
   LB compute        : 269.81 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1995.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.809006483643465e-18,-4.126679466892602e-17,1.6420214797238652e-17)
    sum a = (-8.304294751848574e-17,6.849989325763417e-17,8.855806712948499e-17)
    sum e = 2.5920011309801527
    sum de = -7.148958074826295e-19
Info: CFL hydro = 0.011111685430611912 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011111685430611912 cfl multiplier : 0.9940498864916073        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8647e+04 |  512 |      1 | 2.746e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1453.5401674488062 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.691016616722168, dt = 0.011111685430611912 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.3%)
   patch tree reduce : 1125.00 ns (0.4%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 743.00 ns  (0.2%)
   LB compute        : 296.57 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.558407025265445e-18,-3.962016261946366e-17,1.7704587795819292e-17)
    sum a = (1.3374457791259786e-16,-1.5464582739377342e-16,1.7809972246984884e-17)
    sum e = 2.5920011325847194
    sum de = 6.098637220230962e-20
Info: CFL hydro = 0.011128976587272814 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011128976587272814 cfl multiplier : 0.9960332576610714        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8777e+04 |  512 |      1 | 2.727e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1466.9962720858305 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.70212830215278, dt = 0.011128976587272814 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.4%)
   patch tree reduce : 1035.00 ns (0.4%)
   gen split merge   : 686.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 801.00 ns  (0.3%)
   LB compute        : 273.28 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.66 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.85646679121432e-18,-4.257970928969734e-17,1.7437467485573176e-17)
    sum a = (-2.611192512214089e-17,-1.355595323493386e-16,1.0078266346469356e-16)
    sum e = 2.592001131094543
    sum de = 8.267041565201971e-19
Info: CFL hydro = 0.011141818102716054 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011141818102716054 cfl multiplier : 0.9973555051073809        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8948e+04 |  512 |      1 | 2.702e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1482.6943580964405 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.713257278740052, dt = 0.011141818102716054 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.4%)
   patch tree reduce : 1458.00 ns (0.5%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 843.00 ns  (0.3%)
   LB compute        : 287.75 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.47 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.922020686333074e-18,-4.398776265110427e-17,1.9120691358356922e-17)
    sum a = (-7.314851849238302e-17,3.607953779488637e-17,4.033882602949568e-17)
    sum e = 2.592001126812333
    sum de = 1.3010426069826053e-18
Info: CFL hydro = 0.011152723543569575 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011152723543569575 cfl multiplier : 0.9982370034049207        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9938e+04 |  512 |      1 | 2.568e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1561.993380594036 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.724399096842768, dt = 0.011152723543569575 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.4%)
   patch tree reduce : 1268.00 ns (0.4%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 839.00 ns  (0.3%)
   LB compute        : 288.52 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.981719889720405e-18,-4.262654682354872e-17,1.919533867793255e-17)
    sum a = (-3.0994738026146604e-17,-4.5927861123604143e-17,-7.30080058908289e-17)
    sum e = 2.5920011202258375
    sum de = 1.0164395367051604e-19
Info: CFL hydro = 0.011163333000323294 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011163333000323294 cfl multiplier : 0.9988246689366139        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9682e+04 |  512 |      1 | 2.601e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1543.4441767490312 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.735551820386338, dt = 0.011163333000323294 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.4%)
   patch tree reduce : 1338.00 ns (0.5%)
   gen split merge   : 648.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 770.00 ns  (0.3%)
   LB compute        : 273.21 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.62 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.65 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.025630077706068e-18,-4.367014562467464e-17,1.777896067672001e-17)
    sum a = (1.2381502073610661e-16,-3.488481476344313e-17,2.6603719227580314e-17)
    sum e = 2.5920011119558395
    sum de = -6.2341624917916505e-19
Info: CFL hydro = 0.01117213055743259 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01117213055743259 cfl multiplier : 0.9992164459577427         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9964e+04 |  512 |      1 | 2.565e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1567.0485415473117 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.746715153386662, dt = 0.01117213055743259 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.91 us    (1.4%)
   patch tree reduce : 1385.00 ns (0.5%)
   gen split merge   : 651.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 841.00 ns  (0.3%)
   LB compute        : 269.62 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1882.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.6574072723459815e-18,-4.3981907959372845e-17,1.8707020795708656e-17)
    sum a = (1.3966952594479664e-16,-4.6663356772364e-17,-3.4601228132702386e-18)
    sum e = 2.5920011026513805
    sum de = -4.336808689942018e-19
Info: CFL hydro = 0.011174494252275045 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011174494252275045 cfl multiplier : 0.9994776306384953        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9032e+04 |  512 |      1 | 2.690e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1495.0684271430423 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.757887283944093, dt = 0.011174494252275045 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.97 us    (1.4%)
   patch tree reduce : 1318.00 ns (0.4%)
   gen split merge   : 691.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1035.00 ns (0.4%)
   LB compute        : 277.70 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.2522812568047676e-18,-4.4321480079795305e-17,1.8460025988289303e-17)
    sum a = (1.4625019945091467e-16,1.9118495848957638e-16,-9.279686394303433e-18)
    sum e = 2.5920010929740207
    sum de = 9.486769009248164e-20
Info: CFL hydro = 0.011177218068257605 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011177218068257605 cfl multiplier : 0.999651753758997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9970e+04 |  512 |      1 | 2.564e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1569.02759679736 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 8.769061778196368, dt = 0.011177218068257605 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.3%)
   patch tree reduce : 1415.00 ns (0.4%)
   gen split merge   : 1016.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 814.00 ns  (0.3%)
   LB compute        : 308.51 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.67 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5632026922896002e-18,-4.085550257479364e-17,1.8225655359915827e-17)
    sum a = (-1.1348734452187868e-16,1.5211952791166495e-16,-3.5265735644218755e-17)
    sum e = 2.592001083924861
    sum de = -1.328147661294743e-18
Info: CFL hydro = 0.011180585934641328 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011180585934641328 cfl multiplier : 0.9997678358393314        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9008e+04 |  512 |      1 | 2.694e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1493.8473368137825 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.780238996264625, dt = 0.011180585934641328 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1514.00 ns (0.5%)
   gen split merge   : 693.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 831.00 ns  (0.3%)
   LB compute        : 289.36 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.72 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1900.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.1919592796979545e-18,-3.9443058194588154e-17,1.7877667120129447e-17)
    sum a = (9.920189669720969e-17,4.107944453352053e-17,-6.662986812679475e-17)
    sum e = 2.592001076242121
    sum de = 5.421010862427522e-20
Info: CFL hydro = 0.011184760437163875 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011184760437163875 cfl multiplier : 0.9998452238928875        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8606e+04 |  512 |      1 | 2.752e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1462.648026926197 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.791419582199266, dt = 0.011184760437163875 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.3%)
   patch tree reduce : 1363.00 ns (0.4%)
   gen split merge   : 660.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 883.00 ns  (0.3%)
   LB compute        : 293.89 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.86764666232353e-18,-3.9623089965329374e-17,1.6885113912536858e-17)
    sum a = (1.418943088027369e-16,1.4773729115069578e-16,-1.1472268447720868e-17)
    sum e = 2.5920010705534957
    sum de = 1.8973538018496328e-19
Info: CFL hydro = 0.011189820140210367 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011189820140210367 cfl multiplier : 0.9998968159285916        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8650e+04 |  512 |      1 | 2.745e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1466.6514352696954 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.80260434263643, dt = 0.011189820140210367 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.4%)
   patch tree reduce : 1143.00 ns (0.4%)
   gen split merge   : 973.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 978.00 ns  (0.3%)
   LB compute        : 280.76 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.854691731421724e-20,-3.7469295244632607e-17,1.7181873599673296e-17)
    sum a = (-3.2598923560556156e-17,4.604422312176615e-17,4.6995610528122175e-17)
    sum e = 2.5920010673315663
    sum de = 9.75781955236954e-19
Info: CFL hydro = 0.011195786738325855 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011195786738325855 cfl multiplier : 0.999931210619061         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9211e+04 |  512 |      1 | 2.665e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1511.4704608756022 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.81379416277664, dt = 0.011195786738325855 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1418.00 ns (0.5%)
   gen split merge   : 625.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 275.00 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.72 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3524337899584183e-18,-3.725633083290214e-17,1.7878398956595875e-17)
    sum a = (3.2692598628258907e-17,1.248922840146882e-16,1.4279593132937583e-17)
    sum e = 2.5920010668725166
    sum de = -1.3552527156068805e-19
Info: CFL hydro = 0.011196758556025874 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011196758556025874 cfl multiplier : 0.9999541404127074        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8431e+04 |  512 |      1 | 2.778e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1450.8561169497875 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.824989949514965, dt = 0.011196758556025874 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.3%)
   patch tree reduce : 1312.00 ns (0.4%)
   gen split merge   : 626.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 932.00 ns  (0.3%)
   LB compute        : 287.91 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.318364664277155e-19,-3.553505146386415e-17,1.7906940578786556e-17)
    sum a = (6.191921975151616e-17,4.760742581405575e-17,-1.1847554187705e-16)
    sum e = 2.5920010691134325
    sum de = -2.439454888092385e-19
Info: CFL hydro = 0.011197627953537348 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011197627953537348 cfl multiplier : 0.999969426941805         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8930e+04 |  512 |      1 | 2.705e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1490.3357210513275 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.83618670807099, dt = 0.011197627953537348 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.5%)
   patch tree reduce : 938.00 ns  (0.3%)
   gen split merge   : 716.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 876.00 ns  (0.3%)
   LB compute        : 273.62 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1951.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.756407519426517e-19,-3.542454415743357e-17,1.579614125049242e-17)
    sum a = (8.614593413613925e-17,-5.551125965147507e-17,3.7470027081099036e-18)
    sum e = 2.5920010740326873
    sum de = 3.1170812458958252e-19
Info: CFL hydro = 0.011200518458648284 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011200518458648284 cfl multiplier : 0.9999796179612034        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8692e+04 |  512 |      1 | 2.739e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1471.6551143942934 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.847384336024527, dt = 0.011200518458648284 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.1%)
   patch tree reduce : 1011.00 ns (0.3%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 865.00 ns  (0.3%)
   LB compute        : 329.77 us  (95.5%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.47 us    (72.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1533742710900796e-18,-3.6575722919124364e-17,1.6626043803421447e-17)
    sum a = (-1.0886213805405554e-16,-2.8775809859937776e-17,7.728193085476676e-19)
    sum e = 2.592001081335785
    sum de = -9.893344823930228e-19
Info: CFL hydro = 0.011205359935809558 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011205359935809558 cfl multiplier : 0.9999864119741355        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9359e+04 |  512 |      1 | 2.645e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1524.556087214857 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.858584854483176, dt = 0.011205359935809558 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.3%)
   patch tree reduce : 1150.00 ns (0.4%)
   gen split merge   : 629.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 851.00 ns  (0.3%)
   LB compute        : 286.48 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0948273537758625e-18,-3.68143016071798e-17,1.651864680197318e-17)
    sum a = (-1.997620818761092e-17,7.828893783257129e-17,-2.8863630235909096e-17)
    sum e = 2.592001090516623
    sum de = 2.710505431213761e-19
Info: CFL hydro = 0.011211003386840746 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011211003386840746 cfl multiplier : 0.9999909413160903        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9618e+04 |  512 |      1 | 2.610e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1545.6352865007784 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.869790214418986, dt = 0.011211003386840746 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1173.00 ns (0.4%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 907.00 ns  (0.3%)
   LB compute        : 273.33 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.78 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1852.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.664943762504151e-19,-3.530525481340585e-17,1.608027675858298e-17)
    sum a = (-6.652100745241363e-17,-2.499660634730505e-17,4.887496657390855e-17)
    sum e = 2.592001100916779
    sum de = -1.0977546996415732e-18
Info: CFL hydro = 0.011217637427484311 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011217637427484311 cfl multiplier : 0.9999939608773936        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9896e+04 |  512 |      1 | 2.573e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1568.3679448558196 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.881001217805826, dt = 0.011217637427484311 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.87 us    (1.7%)
   patch tree reduce : 1116.00 ns (0.4%)
   gen split merge   : 650.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 867.00 ns  (0.3%)
   LB compute        : 274.05 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1893.00 ns (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.7505528276950955e-18,-3.615930796972699e-17,1.6991047241052272e-17)
    sum a = (1.1454704372526603e-16,-1.0945199824599627e-16,1.1123914289701275e-17)
    sum e = 2.592001111836024
    sum de = -2.168404344971009e-19
Info: CFL hydro = 0.011225937075046384 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011225937075046384 cfl multiplier : 0.9999959739182623        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9153e+04 |  512 |      1 | 2.673e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.6967277632946 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.89221885523331, dt = 0.011225937075046384 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.4%)
   patch tree reduce : 910.00 ns  (0.3%)
   gen split merge   : 647.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 959.00 ns  (0.3%)
   LB compute        : 272.12 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.65 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.54 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.742300302451596e-19,-3.791937467148565e-17,1.6938355015469474e-17)
    sum a = (5.95890524424103e-17,-5.7901437550828e-17,-2.71657696337968e-17)
    sum e = 2.5920011225734587
    sum de = 1.1519648082658485e-19
Info: CFL hydro = 0.011216654756288006 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011216654756288006 cfl multiplier : 0.9999973159455081        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8298e+04 |  512 |      1 | 2.798e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1444.2685895968943 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.903444792308356, dt = 0.011216654756288006 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.1%)
   patch tree reduce : 1327.00 ns (0.3%)
   gen split merge   : 702.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1076.00 ns (0.3%)
   LB compute        : 387.74 us  (95.9%)
   LB move op cnt    : 0
   LB apply          : 3.54 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.318364664277155e-19,-3.828602474116593e-17,1.6398259703245822e-17)
    sum a = (2.5116627527799196e-18,-6.8842026805689125e-18,1.5380275178444868e-16)
    sum e = 2.5920011318427387
    sum de = 2.710505431213761e-20
Info: CFL hydro = 0.011208095947699726 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011208095947699726 cfl multiplier : 0.9999982106303387        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7010e+04 |  512 |      1 | 3.010e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1341.521332741292 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 8.914661447064644, dt = 0.011208095947699726 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.6%)
   patch tree reduce : 1296.00 ns (0.4%)
   gen split merge   : 663.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 917.00 ns  (0.3%)
   LB compute        : 277.37 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1883.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.327769475593768e-19,-3.8110383989223287e-17,1.9150696653480458e-17)
    sum a = (5.308741727466648e-17,-7.233910736051397e-17,1.1004478578380273e-16)
    sum e = 2.592001139529796
    sum de = 3.2864878353466853e-19
Info: CFL hydro = 0.011201668729440447 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011201668729440447 cfl multiplier : 0.9999988070868925        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8368e+04 |  512 |      1 | 2.787e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1447.5211495648916 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.925869543012343, dt = 0.011201668729440447 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.4%)
   patch tree reduce : 1221.00 ns (0.4%)
   gen split merge   : 632.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 872.00 ns  (0.3%)
   LB compute        : 301.47 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.35828848168984e-18,-3.931645048589616e-17,2.014599424782215e-17)
    sum a = (-4.9860750294186685e-17,7.642421851611347e-17,6.334776453398305e-18)
    sum e = 2.5920011452584664
    sum de = 7.352245982167327e-19
Info: CFL hydro = 0.011197448961278932 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011197448961278932 cfl multiplier : 0.999999204724595         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8351e+04 |  512 |      1 | 2.790e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1445.3499308520152 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.937071211741783, dt = 0.011197448961278932 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.56 us    (1.5%)
   patch tree reduce : 1263.00 ns (0.4%)
   gen split merge   : 655.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1331.00 ns (0.4%)
   LB compute        : 285.27 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1931.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.283329775254472e-19,-3.7536624199543955e-17,1.9671764217576992e-17)
    sum a = (-8.203154952188263e-17,8.379527540597342e-17,6.696596402400168e-17)
    sum e = 2.5920011487592407
    sum de = -1.2850548601031804e-18
Info: CFL hydro = 0.011195480258970865 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011195480258970865 cfl multiplier : 0.9999994698163966        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9186e+04 |  512 |      1 | 2.669e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.5867186105668 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.94826866070306, dt = 0.011195480258970865 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 2.01 us    (0.7%)
   gen split merge   : 768.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 877.00 ns  (0.3%)
   LB compute        : 285.30 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.36 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1865.00 ns (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.430756093247282e-19,-3.64974164172166e-17,2.0850020928525615e-17)
    sum a = (1.3158419666370326e-16,4.7434712407978805e-17,1.7165956156528495e-17)
    sum e = 2.592001149964549
    sum de = -1.5449880957918438e-18
Info: CFL hydro = 0.011195774143522602 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011195774143522602 cfl multiplier : 0.9999996465442645        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8529e+04 |  512 |      1 | 2.763e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1458.5859601723125 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.959464140962032, dt = 0.011195774143522602 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.4%)
   patch tree reduce : 1355.00 ns (0.4%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 935.00 ns  (0.3%)
   LB compute        : 292.04 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.53 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8559372788606863e-18,-3.626615609382544e-17,2.066559813898583e-17)
    sum a = (-7.810744238889722e-17,3.059661898840993e-17,1.603014596063268e-17)
    sum e = 2.5920011489868244
    sum de = -1.1485766764768313e-18
Info: CFL hydro = 0.011198309279817364 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011198309279817364 cfl multiplier : 0.9999997643628431        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9047e+04 |  512 |      1 | 2.688e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1499.3491408961652 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.970659915105555, dt = 0.011198309279817364 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.4%)
   patch tree reduce : 1832.00 ns (0.6%)
   gen split merge   : 716.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 924.00 ns  (0.3%)
   LB compute        : 279.44 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1977.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.283329775254472e-19,-3.608392881368494e-17,2.0842702563861338e-17)
    sum a = (1.5163651584382266e-18,1.600087250197557e-17,4.332471881252076e-18)
    sum e = 2.592001146116058
    sum de = 8.605854744103691e-19
Info: CFL hydro = 0.011203032675403658 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011203032675403658 cfl multiplier : 0.999999842908562         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9862e+04 |  512 |      1 | 2.578e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1563.9112034240902 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.981858224385373, dt = 0.011203032675403658 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.5%)
   patch tree reduce : 1320.00 ns (0.5%)
   gen split merge   : 756.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1056.00 ns (0.4%)
   LB compute        : 274.03 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1865.00 ns (63.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.283329775254472e-19,-3.5825590541035956e-17,2.081342910520423e-17)
    sum a = (2.462132060732092e-16,-1.0207655033733776e-16,-2.0795865030009963e-17)
    sum e = 2.5920011417581783
    sum de = 7.250602028496811e-19
Info: CFL hydro = 0.01120985970325535 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01120985970325535 cfl multiplier : 0.9999998952723747         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9126e+04 |  512 |      1 | 2.677e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1506.5782002554051 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 8.993061257060777, dt = 0.006938742939222919 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1633.00 ns (0.6%)
   gen split merge   : 676.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 272.63 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1942.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.413285279418865e-18,-3.716924229339724e-17,2.0596805511141626e-17)
    sum a = (-5.396854838024545e-17,4.24465150528075e-18,7.243424610114956e-17)
    sum e = 2.5920010321982345
    sum de = 1.1587410718438829e-18
Info: CFL hydro = 0.011215686261559246 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011215686261559246 cfl multiplier : 0.9999999301815832        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0047e+04 |  512 |      1 | 2.554e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 978.0411663445944 (tsim/hr)                             [sph::Model][rank=0]
Info: iteration since start : 1162                                                    [SPH][rank=0]
Info: time since start : 1774.4718281050002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14986401330811372 max=0.1501749224721729 delta=0.000310909164059181
Number of particle pairs: 130816
Distance min=0.147342 max=1.992069 mean=0.804844
---------------- t = 9, dt = 0.011215686261559246 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 8.71 us    (1.3%)
   patch tree reduce : 1329.00 ns (0.2%)
   gen split merge   : 576.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 872.00 ns  (0.1%)
   LB compute        : 649.25 us  (96.1%)
   LB move op cnt    : 0
   LB apply          : 6.32 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.83 us    (77.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7212793690379868e-18,-3.6834793028239775e-17,2.1676996135588933e-17)
    sum a = (-2.0185806151595819e-16,-1.8535954021681178e-17,1.0555423722580226e-16)
    sum e = 2.592001133431163
    sum de = -3.6591823321385775e-19
Info: CFL hydro = 0.011225063649758964 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011225063649758964 cfl multiplier : 0.9999999534543887        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6110e+04 |  512 |      1 | 3.178e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1270.4440606366695 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.01121568626156, dt = 0.011225063649758964 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1684.00 ns (0.5%)
   gen split merge   : 723.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 940.00 ns  (0.3%)
   LB compute        : 291.74 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.37 us    (71.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3524337899584183e-18,-3.714216434413942e-17,2.3070412767667304e-17)
    sum a = (2.3594407677629548e-17,-4.3594034632166157e-17,-9.471134813920923e-17)
    sum e = 2.5920011275977686
    sum de = -9.486769009248164e-19
Info: CFL hydro = 0.011222833243521881 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011222833243521881 cfl multiplier : 0.9999999689695924        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8377e+04 |  512 |      1 | 2.786e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1450.464847447292 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 9.022440749911318, dt = 0.011222833243521881 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.5%)
   patch tree reduce : 1134.00 ns (0.4%)
   gen split merge   : 644.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 843.00 ns  (0.3%)
   LB compute        : 278.78 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1990.00 ns (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.3957212042246e-19,-3.780667185565578e-17,2.0895394789444133e-17)
    sum a = (1.0826495949745052e-16,2.923833050672009e-17,-5.342406204922323e-17)
    sum e = 2.5920011222590875
    sum de = -9.486769009248164e-19
Info: CFL hydro = 0.011214500510347713 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011214500510347713 cfl multiplier : 0.9999999793130616        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7670e+04 |  512 |      1 | 2.898e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1394.3435279608555 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.03366358315484, dt = 0.011214500510347713 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.69 us    (1.6%)
   patch tree reduce : 1284.00 ns (0.4%)
   gen split merge   : 622.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1329.00 ns (0.5%)
   LB compute        : 273.01 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.891065429249217e-18,-3.702214316364527e-17,2.0503130443438878e-17)
    sum a = (3.0210209334136094e-17,1.905116689404629e-17,-6.835352596434863e-18)
    sum e = 2.5920011179103795
    sum de = 5.285485590866834e-19
Info: CFL hydro = 0.011207536250674912 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011207536250674912 cfl multiplier : 0.9999999862087078        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9309e+04 |  512 |      1 | 2.652e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1522.5913852824006 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.04487808366519, dt = 0.011207536250674912 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.5%)
   patch tree reduce : 1314.00 ns (0.4%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 906.00 ns  (0.3%)
   LB compute        : 283.19 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.990595188683386e-18,-3.675575468986558e-17,2.071975403750148e-17)
    sum a = (-4.6568218031728394e-17,-1.2874467117396371e-16,1.007124071639165e-16)
    sum e = 2.5920011151089284
    sum de = 3.5236570605778894e-19
Info: CFL hydro = 0.011202015731068703 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011202015731068703 cfl multiplier : 0.9999999908058053        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8936e+04 |  512 |      1 | 2.704e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1492.1908488588192 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.056085619915864, dt = 0.011202015731068703 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.65 us    (1.5%)
   patch tree reduce : 1393.00 ns (0.4%)
   gen split merge   : 717.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1211.00 ns (0.4%)
   LB compute        : 299.78 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0655538951187537e-18,-3.919423379600273e-17,2.2464452173465156e-17)
    sum a = (-2.343047630914974e-17,-4.756351562607008e-17,9.158201540876431e-17)
    sum e = 2.5920011140812718
    sum de = 1.0842021724855044e-19
Info: CFL hydro = 0.011197994304142029 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011197994304142029 cfl multiplier : 0.9999999938705368        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8988e+04 |  512 |      1 | 2.696e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1495.5958375121074 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.067287635646933, dt = 0.011197994304142029 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.96 us    (1.3%)
   patch tree reduce : 1275.00 ns (0.4%)
   gen split merge   : 667.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 809.00 ns  (0.3%)
   LB compute        : 279.54 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1886.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.138021506676197e-19,-3.921765256292842e-17,2.350365995579251e-17)
    sum a = (-8.366354484201643e-17,1.4600430239819496e-16,1.63053164720095e-17)
    sum e = 2.592001114870089
    sum de = 8.131516293641283e-19
Info: CFL hydro = 0.01118815793287658 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01118815793287658 cfl multiplier : 0.9999999959136913         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8205e+04 |  512 |      1 | 2.812e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1433.3864381590904 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.078485629951075, dt = 0.01118815793287658 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.88 us    (1.2%)
   patch tree reduce : 1204.00 ns (0.4%)
   gen split merge   : 1065.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 865.00 ns  (0.3%)
   LB compute        : 313.05 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.97 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.37 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.679050979479072e-19,-3.643521031757024e-17,2.3143596414310074e-17)
    sum a = (3.354738362104648e-17,-4.2411386902418967e-17,2.1650650022797536e-17)
    sum e = 2.5920011171534285
    sum de = 6.098637220230962e-19
Info: CFL hydro = 0.011177659831969134 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011177659831969134 cfl multiplier : 0.9999999972757943        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8421e+04 |  512 |      1 | 2.779e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1449.1537784424252 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.089673787883951, dt = 0.011177659831969134 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.94 us    (1.2%)
   patch tree reduce : 1271.00 ns (0.4%)
   gen split merge   : 714.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 907.00 ns  (0.3%)
   LB compute        : 322.07 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.269222558279552e-19,-3.804817788957693e-17,2.35007326099268e-17)
    sum a = (-7.335343270298278e-17,4.5631467354700914e-17,6.03969999013465e-17)
    sum e = 2.5920011207549174
    sum de = -8.131516293641283e-20
Info: CFL hydro = 0.011170125570685004 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011170125570685004 cfl multiplier : 0.9999999981838629        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8323e+04 |  512 |      1 | 2.794e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1440.0253837602172 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.10085144771592, dt = 0.011170125570685004 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.5%)
   patch tree reduce : 1382.00 ns (0.5%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 283.30 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1928.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-8.89913143176102e-19,-3.7039707238839533e-17,2.4354053929781515e-17)
    sum a = (-2.1556974955094788e-17,-7.40852691694105e-17,-4.591249255780916e-17)
    sum e = 2.5920011253347512
    sum de = 2.168404344971009e-19
Info: CFL hydro = 0.011165601947730273 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011165601947730273 cfl multiplier : 0.999999998789242         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9272e+04 |  512 |      1 | 2.657e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1513.616316822773 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 9.112021573286604, dt = 0.011165601947730273 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.02 us    (0.5%)
   patch tree reduce : 1545.00 ns (0.1%)
   gen split merge   : 901.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 999.00 ns  (0.1%)
   LB compute        : 1067.47 us (98.3%)
   LB move op cnt    : 0
   LB apply          : 3.47 us    (0.3%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.35 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.849989325763417e-19,-3.82691925024381e-17,2.3206534350422857e-17)
    sum a = (1.0241026776602879e-16,7.09588637848313e-17,7.529133566608337e-18)
    sum e = 2.5920011303802166
    sum de = -1.0706496453294356e-18
Info: CFL hydro = 0.01116409074309654 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01116409074309654 cfl multiplier : 0.9999999991928279         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7225e+04 |  512 |      1 | 2.972e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1352.2880864886502 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.123187175234335, dt = 0.01116409074309654 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.5%)
   patch tree reduce : 1523.00 ns (0.5%)
   gen split merge   : 824.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 935.00 ns  (0.3%)
   LB compute        : 283.11 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.63 us    (70.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1475195793586579e-18,-3.680844691544838e-17,2.3575379929502427e-17)
    sum a = (4.9679986686979037e-17,8.463542366943244e-17,-6.099417845795152e-17)
    sum e = 2.592001135317074
    sum de = -2.846030702774449e-19
Info: CFL hydro = 0.011165561791027649 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011165561791027649 cfl multiplier : 0.9999999994618852        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7029e+04 |  512 |      1 | 3.007e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1336.7086920795552 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.13435126597743, dt = 0.011165561791027649 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1368.00 ns (0.5%)
   gen split merge   : 738.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1594.00 ns (0.5%)
   LB compute        : 277.63 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3407244064955747e-18,-3.593317050160083e-17,2.2552272549436482e-17)
    sum a = (3.4545608561253883e-17,-7.723509332091538e-17,-1.5339292336324916e-17)
    sum e = 2.5920011395951965
    sum de = 1.7414997395548415e-18
Info: CFL hydro = 0.01116994932634342 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01116994932634342 cfl multiplier : 0.9999999996412567         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9141e+04 |  512 |      1 | 2.675e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1502.6946485019337 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.145516827768459, dt = 0.01116994932634342 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1311.00 ns (0.4%)
   gen split merge   : 722.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 874.00 ns  (0.3%)
   LB compute        : 286.24 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.569057384021022e-18,-3.768372332929592e-17,2.265765700060207e-17)
    sum a = (-7.170240963472185e-17,1.403076873435216e-16,4.166198636079699e-17)
    sum e = 2.5920011427036287
    sum de = -9.486769009248164e-19
Info: CFL hydro = 0.011177146928631254 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011177146928631254 cfl multiplier : 0.9999999997608379        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8627e+04 |  512 |      1 | 2.749e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1462.9269226937297 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.156686777094801, dt = 0.011177146928631254 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.2%)
   patch tree reduce : 1414.00 ns (0.4%)
   gen split merge   : 759.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 976.00 ns  (0.3%)
   LB compute        : 341.52 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.283329775254472e-19,-3.493787290725914e-17,2.33792477564998e-17)
    sum a = (6.009255593131257e-17,-2.971256053696525e-17,2.330167309105846e-17)
    sum e = 2.5920011442371127
    sum de = 2.2293907171733185e-18
Info: CFL hydro = 0.011187013937152072 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011187013937152072 cfl multiplier : 0.9999999998405587        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8644e+04 |  512 |      1 | 2.746e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1465.2151239663265 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.167863924023433, dt = 0.011187013937152072 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.84 us    (1.3%)
   patch tree reduce : 1233.00 ns (0.4%)
   gen split merge   : 763.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 842.00 ns  (0.3%)
   LB compute        : 275.77 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.40 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1829.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8383732036664213e-18,-3.6287379351351846e-17,2.3467799968937552e-17)
    sum a = (7.644763728303916e-17,5.903871141965666e-17,-2.203705967707137e-17)
    sum e = 2.5920011439163577
    sum de = -4.1335207826009857e-19
Info: CFL hydro = 0.011195184168965382 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011195184168965382 cfl multiplier : 0.9999999998937058        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9693e+04 |  512 |      1 | 2.600e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1549.0318706624487 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.179050937960584, dt = 0.011195184168965382 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.3%)
   patch tree reduce : 1086.00 ns (0.4%)
   gen split merge   : 802.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 891.00 ns  (0.3%)
   LB compute        : 286.75 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1910.00 ns (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5702096700941368e-18,-3.497885574937909e-17,2.296941933530028e-17)
    sum a = (1.2502694192451092e-16,4.800847219765814e-19,-1.1287845658181083e-17)
    sum e = 2.592001141547103
    sum de = -7.962109704190423e-19
Info: CFL hydro = 0.011198267361174612 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011198267361174612 cfl multiplier : 0.9999999999291372        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8425e+04 |  512 |      1 | 2.779e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1450.3099430809086 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.19024612212955, dt = 0.011198267361174612 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.5%)
   patch tree reduce : 1531.00 ns (0.5%)
   gen split merge   : 717.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 12.78 us   (4.2%)
   LB compute        : 275.99 us  (90.6%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.355890648177763e-18,-3.542381232096714e-17,2.273340207487734e-17)
    sum a = (-6.596481173792856e-17,4.32017702861609e-17,-2.7634144972310537e-18)
    sum e = 2.592001137165128
    sum de = -1.2366681029912785e-19
Info: CFL hydro = 0.011201834379572432 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011201834379572432 cfl multiplier : 0.9999999999527581        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8536e+04 |  512 |      1 | 2.762e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1459.484019371443 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 9.201444389490725, dt = 0.011201834379572432 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.5%)
   patch tree reduce : 1089.00 ns (0.3%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1593.00 ns (0.5%)
   LB compute        : 294.41 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.57 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3418766925686897e-18,-3.4522189794328195e-17,2.2966674948551174e-17)
    sum a = (5.702469746404759e-18,2.0222983444090348e-16,2.3676373361869452e-17)
    sum e = 2.5920011312483067
    sum de = 1.0326919813806023e-18
Info: CFL hydro = 0.011199297453679423 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011199297453679423 cfl multiplier : 0.9999999999685055        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6161e+04 |  512 |      1 | 3.168e-02 | 0.0% |   1.5% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1272.8686663086073 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.212646223870298, dt = 0.011199297453679423 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.5%)
   patch tree reduce : 1288.00 ns (0.4%)
   gen split merge   : 764.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 880.00 ns  (0.3%)
   LB compute        : 276.16 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1878.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.120550692847779e-18,-3.1536297011303114e-17,2.329687041424753e-17)
    sum a = (4.0602287157409657e-17,-9.294176756338701e-17,-1.6627324517237694e-17)
    sum e = 2.5920011241006082
    sum de = 1.5026364484291288e-18
Info: CFL hydro = 0.011196024638742707 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011196024638742707 cfl multiplier : 0.9999999999790038        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9345e+04 |  512 |      1 | 2.647e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.3126736171885 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.223845521323977, dt = 0.011196024638742707 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.4%)
   patch tree reduce : 1333.00 ns (0.4%)
   gen split merge   : 729.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 907.00 ns  (0.3%)
   LB compute        : 300.79 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.45 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (70.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.6123447982872034e-18,-3.4001122230231664e-17,2.289916303452322e-17)
    sum a = (-6.191336505978473e-17,-5.328940413940053e-17,-6.64858793020251e-17)
    sum e = 2.5920011165109944
    sum de = 1.1926223897340549e-18
Info: CFL hydro = 0.011186650513442949 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011186650513442949 cfl multiplier : 0.9999999999860026        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0368e+04 |  512 |      1 | 2.514e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1603.408863366787 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 9.23504154596272, dt = 0.011186650513442949 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1786.00 ns (0.6%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 796.00 ns  (0.3%)
   LB compute        : 296.40 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.33 us    (71.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.4062783016143284e-18,-3.434947638825125e-17,2.1822265674174835e-17)
    sum a = (3.9683100555576445e-17,1.5742387862033303e-16,6.075999078869465e-17)
    sum e = 2.5920011090701363
    sum de = 4.0996394647108136e-19
Info: CFL hydro = 0.011173400332660717 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011173400332660717 cfl multiplier : 0.9999999999906685        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7723e+04 |  512 |      1 | 2.889e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1394.0330456230308 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.246228196476162, dt = 0.011173400332660717 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.02 us    (1.3%)
   patch tree reduce : 1238.00 ns (0.4%)
   gen split merge   : 787.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1202.00 ns (0.4%)
   LB compute        : 284.77 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.571361956167251e-18,-3.150702355264601e-17,2.326654494066993e-17)
    sum a = (1.268243322860574e-16,9.134782773950744e-17,5.823076396072046e-17)
    sum e = 2.5920011025810146
    sum de = -5.963111948670274e-19
Info: CFL hydro = 0.01116259528283753 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01116259528283753 cfl multiplier : 0.9999999999937789         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9080e+04 |  512 |      1 | 2.683e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1498.9964340756162 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.257401596808823, dt = 0.01116259528283753 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.5%)
   patch tree reduce : 1908.00 ns (0.6%)
   gen split merge   : 668.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 808.00 ns  (0.3%)
   LB compute        : 284.77 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (71.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.357042934250877e-18,-3.086593480805533e-17,2.3918611232257026e-17)
    sum a = (-3.698994235912245e-17,5.280931941742395e-17,-3.79735305700013e-17)
    sum e = 2.5920010978861763
    sum de = -1.463672932855431e-18
Info: CFL hydro = 0.01115441119186095 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115441119186095 cfl multiplier : 0.9999999999958525         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4934e+04 |  512 |      1 | 3.428e-02 | 0.0% |   1.5% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1172.1640018663197 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.26856419209166, dt = 0.01115441119186095 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.93 us    (1.7%)
   patch tree reduce : 1408.00 ns (0.5%)
   gen split merge   : 714.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 897.00 ns  (0.3%)
   LB compute        : 279.08 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.94020753524682e-18,-3.033608520636166e-17,2.2967223825900996e-17)
    sum a = (-1.4870916997811178e-18,-1.42784221945913e-16,9.566566289143097e-18)
    sum e = 2.592001095574105
    sum de = -4.336808689942018e-19
Info: CFL hydro = 0.011148991679075636 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011148991679075636 cfl multiplier : 0.9999999999972351        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8855e+04 |  512 |      1 | 2.715e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1478.8108702829172 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.27971860328352, dt = 0.011148991679075636 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.4%)
   patch tree reduce : 1317.00 ns (0.4%)
   gen split merge   : 709.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 962.00 ns  (0.3%)
   LB compute        : 283.74 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1944.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.24465150528075e-18,-3.321659353822115e-17,2.3390225303496215e-17)
    sum a = (-5.660315965938523e-17,-2.1176419992552374e-17,-2.4607269347165505e-17)
    sum e = 2.592001096082813
    sum de = -1.8295911660692887e-19
Info: CFL hydro = 0.01114644661985906 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114644661985906 cfl multiplier : 0.9999999999981567         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8453e+04 |  512 |      1 | 2.775e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1446.5343698916136 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.290867594962595, dt = 0.01114644661985906 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.6%)
   patch tree reduce : 1953.00 ns (0.7%)
   gen split merge   : 683.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 911.00 ns  (0.3%)
   LB compute        : 277.03 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.331319595178961e-18,-3.271016270345317e-17,2.2842811626608283e-17)
    sum a = (-4.9319923145496604e-17,-1.882283391652084e-17,2.6024104746169563e-17)
    sum e = 2.5920010996650316
    sum de = 7.453889935837843e-19
Info: CFL hydro = 0.011146847758716443 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011146847758716443 cfl multiplier : 0.9999999999987711        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8215e+04 |  512 |      1 | 2.811e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1427.5349939033865 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.302014041582455, dt = 0.011146847758716443 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1366.00 ns (0.5%)
   gen split merge   : 679.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1548.00 ns (0.5%)
   LB compute        : 273.06 us  (90.6%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (58.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.8922177153223315e-18,-3.296776913963573e-17,2.345243140314257e-17)
    sum a = (6.94249345511988e-17,6.237588570656705e-17,5.672610818574509e-17)
    sum e = 2.592001106358701
    sum de = 5.692061405548898e-19
Info: CFL hydro = 0.011150229542132547 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011150229542132547 cfl multiplier : 0.9999999999991808        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6652e+04 |  512 |      1 | 3.075e-02 | 0.0% |   1.5% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1305.1409492696885 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.313160889341171, dt = 0.011150229542132547 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.4%)
   patch tree reduce : 1869.00 ns (0.6%)
   gen split merge   : 752.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 929.00 ns  (0.3%)
   LB compute        : 286.31 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.350035956446341e-18,-3.184074098133704e-17,2.4308680068862998e-17)
    sum a = (1.6503205052531556e-16,1.8283616808056902e-16,-1.0825471378692053e-16)
    sum e = 2.5920011159765015
    sum de = 6.098637220230962e-20
Info: CFL hydro = 0.011156589001773895 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011156589001773895 cfl multiplier : 0.9999999999994538        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8395e+04 |  512 |      1 | 2.783e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1442.1483483709292 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.324311118883303, dt = 0.011156589001773895 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 1820.00 ns (0.6%)
   gen split merge   : 669.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 902.00 ns  (0.3%)
   LB compute        : 283.85 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1896.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.732895491134983e-18,-2.913001870968879e-17,2.2129271071841262e-17)
    sum a = (-6.489925784280981e-17,1.1674255312454917e-16,1.4835788847422647e-17)
    sum e = 2.5920011281065887
    sum de = 1.2332799712022613e-18
Info: CFL hydro = 0.011165884795498408 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011165884795498408 cfl multiplier : 0.9999999999996358        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6081e+04 |  512 |      1 | 3.184e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1261.4844728468327 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.335467707885076, dt = 0.011165884795498408 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.71 us    (1.6%)
   patch tree reduce : 1144.00 ns (0.4%)
   gen split merge   : 672.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 955.00 ns  (0.3%)
   LB compute        : 276.47 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.554950167046101e-18,-2.811422969428712e-17,2.294014587664317e-17)
    sum a = (-1.2552459072168176e-17,2.958961201060539e-17,9.835882108788495e-19)
    sum e = 2.592001142133324
    sum de = 3.1170812458958252e-19
Info: CFL hydro = 0.011177282873909488 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011177282873909488 cfl multiplier : 0.9999999999997572        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5867e+04 |  512 |      1 | 3.227e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1245.7418758552453 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.346633592680575, dt = 0.011177282873909488 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.3%)
   patch tree reduce : 1536.00 ns (0.5%)
   gen split merge   : 638.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 874.00 ns  (0.3%)
   LB compute        : 311.76 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.35 us    (70.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.900376979199983e-18,-2.8342562671812564e-17,2.2982592391695978e-17)
    sum a = (-6.16089210897508e-17,-1.5110373889626326e-16,-2.764585435577338e-17)
    sum e = 2.5920011572426804
    sum de = 6.166399856011306e-19
Info: CFL hydro = 0.011191202249180996 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011191202249180996 cfl multiplier : 0.999999999999838         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8688e+04 |  512 |      1 | 2.740e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1468.682279482471 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 9.357810875554485, dt = 0.011191202249180996 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (0.7%)
   patch tree reduce : 1238.00 ns (0.2%)
   gen split merge   : 908.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 946.00 ns  (0.1%)
   LB compute        : 615.21 us  (97.4%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (0.5%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (70.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.6943104825271076e-18,-3.0947900492295235e-17,2.2453474626468738e-17)
    sum a = (-2.6375386250054867e-17,-4.842415531058908e-17,4.93726153710794e-17)
    sum e = 2.5920011725268095
    sum de = 1.0367683274392636e-18
Info: CFL hydro = 0.011200086580508367 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011200086580508367 cfl multiplier : 0.999999999999892         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6924e+04 |  512 |      1 | 3.025e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1331.7301696620464 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.369002077803666, dt = 0.011200086580508367 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1804.00 ns (0.6%)
   gen split merge   : 731.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 914.00 ns  (0.3%)
   LB compute        : 289.38 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1889.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.799694933692699e-18,-3.092155437950384e-17,2.3469263641870407e-17)
    sum a = (-9.658777683912989e-17,-1.2506207007489944e-16,-7.848799735143963e-17)
    sum e = 2.5920011867611805
    sum de = -3.7947076036992655e-19
Info: CFL hydro = 0.011207999085831036 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011207999085831036 cfl multiplier : 0.9999999999999281        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8987e+04 |  512 |      1 | 2.697e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1495.2326362939298 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.380202164384174, dt = 0.011207999085831036 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.3%)
   patch tree reduce : 1369.00 ns (0.5%)
   gen split merge   : 657.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 976.00 ns  (0.3%)
   LB compute        : 282.13 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.289184466985894e-18,-3.2698453319990326e-17,2.183800015820303e-17)
    sum a = (-8.385967701501906e-17,-9.674878086174399e-17,5.984665887859286e-17)
    sum e = 2.592001199044174
    sum de = -1.179069862577986e-18
Info: CFL hydro = 0.01121436186800866 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01121436186800866 cfl multiplier : 0.999999999999952          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9265e+04 |  512 |      1 | 2.658e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.2363576183413 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.391410163470006, dt = 0.01121436186800866 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.5%)
   patch tree reduce : 1201.00 ns (0.4%)
   gen split merge   : 646.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1656.00 ns (0.6%)
   LB compute        : 270.34 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.56 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5163651584382266e-18,-3.358543911730072e-17,2.3271667795934924e-17)
    sum a = (-1.3358540348114983e-16,-4.3037838917681094e-17,-2.4917568008930855e-17)
    sum e = 2.5920012084451063
    sum de = -1.2739375526704677e-18
Info: CFL hydro = 0.01120364577429314 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01120364577429314 cfl multiplier : 0.999999999999968          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9110e+04 |  512 |      1 | 2.679e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1506.8293487831074 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.402624525338014, dt = 0.01120364577429314 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.3%)
   patch tree reduce : 1457.00 ns (0.5%)
   gen split merge   : 791.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 969.00 ns  (0.3%)
   LB compute        : 297.86 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.2786273695961654e-19,-3.3878173703871806e-17,2.256471376936575e-17)
    sum a = (-1.2570315881949012e-16,2.792687955888162e-17,2.907439913824028e-17)
    sum e = 2.5920012136584605
    sum de = 6.776263578034403e-19
Info: CFL hydro = 0.011193390916009537 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011193390916009537 cfl multiplier : 0.9999999999999787        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9801e+04 |  512 |      1 | 2.586e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1559.8663138974134 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.413828171112307, dt = 0.011193390916009537 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.4%)
   patch tree reduce : 1708.00 ns (0.5%)
   gen split merge   : 729.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 990.00 ns  (0.3%)
   LB compute        : 303.87 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.65 us    (72.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.7212793690379868e-18,-3.3199029463026885e-17,2.3198484149292152e-17)
    sum a = (3.328099514726679e-17,6.243443262388126e-17,-1.4402541659297442e-18)
    sum e = 2.5920012147968623
    sum de = -1.1519648082658485e-18
Info: CFL hydro = 0.011183752637050095 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011183752637050095 cfl multiplier : 0.9999999999999858        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9219e+04 |  512 |      1 | 2.664e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1512.5667388162967 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.425021562028316, dt = 0.011183752637050095 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.97 us    (1.1%)
   patch tree reduce : 1239.00 ns (0.3%)
   gen split merge   : 751.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1165.00 ns (0.3%)
   LB compute        : 340.88 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 3.40 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.917941054394248e-19,-3.232668039504505e-17,2.299722912102453e-17)
    sum a = (-3.459537344097097e-17,-7.88041507049364e-18,9.226994168720637e-18)
    sum e = 2.592001211660742
    sum de = 1.1180834903756764e-19
Info: CFL hydro = 0.011174883037392424 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011174883037392424 cfl multiplier : 0.9999999999999906        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9356e+04 |  512 |      1 | 2.645e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1522.0375475299586 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.436205314665367, dt = 0.011174883037392424 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.3%)
   patch tree reduce : 998.00 ns  (0.3%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 847.00 ns  (0.3%)
   LB compute        : 284.07 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 2.46 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1592289628215014e-18,-3.266478884253465e-17,2.3070412767667304e-17)
    sum a = (-3.551456004280418e-17,2.177359854915739e-17,-1.0958811982875182e-16)
    sum e = 2.5920012044017873
    sum de = 1.1146953585866592e-18
Info: CFL hydro = 0.011166926555371846 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011166926555371846 cfl multiplier : 0.9999999999999938        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8049e+04 |  512 |      1 | 2.837e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1418.194606137104 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 9.44738019770276, dt = 0.011166926555371846 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.5%)
   patch tree reduce : 1306.00 ns (0.5%)
   gen split merge   : 610.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1003.00 ns (0.3%)
   LB compute        : 274.02 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1844.00 ns (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6510230682609261e-18,-3.235156283490359e-17,2.1218500589371968e-17)
    sum a = (4.443711024149088e-18,-7.141260239401647e-17,-4.777428452840127e-18)
    sum e = 2.5920011933944944
    sum de = -1.1858461261560205e-20
Info: CFL hydro = 0.011160017475664736 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011160017475664736 cfl multiplier : 0.9999999999999959        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9184e+04 |  512 |      1 | 2.669e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1506.2754997454244 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.458547124258132, dt = 0.011160017475664736 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.56 us    (1.1%)
   patch tree reduce : 1262.00 ns (0.3%)
   gen split merge   : 676.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1309.00 ns (0.3%)
   LB compute        : 408.71 us  (96.1%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2119211884042968e-18,-3.3679114185003466e-17,2.1749082027532063e-17)
    sum a = (1.4442353563071107e-16,6.415278464705354e-18,-2.4753636640451047e-17)
    sum e = 2.592001179347785
    sum de = 7.674118502123961e-19
Info: CFL hydro = 0.011154279441324633 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011154279441324633 cfl multiplier : 0.9999999999999973        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9754e+04 |  512 |      1 | 2.592e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1550.0392047262328 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.469707141733796, dt = 0.011154279441324633 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.4%)
   patch tree reduce : 1250.00 ns (0.4%)
   gen split merge   : 651.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 851.00 ns  (0.3%)
   LB compute        : 284.37 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.55 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.72 us    (70.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0421351281930669e-18,-3.318439273369833e-17,2.138645705841713e-17)
    sum a = (-1.406296953887498e-17,1.9179238275671138e-17,9.558369720719107e-17)
    sum e = 2.5920011631267674
    sum de = 5.266427349553612e-19
Info: CFL hydro = 0.011149823411266434 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011149823411266434 cfl multiplier : 0.9999999999999982        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7792e+04 |  512 |      1 | 2.878e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1395.3995540107182 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.48086142117512, dt = 0.011149823411266434 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.4%)
   patch tree reduce : 1283.00 ns (0.4%)
   gen split merge   : 889.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1167.00 ns (0.4%)
   LB compute        : 285.13 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.782037597132585e-20,-3.2660397823736084e-17,2.3114322955652967e-17)
    sum a = (1.116255525512866e-16,4.3295445353863647e-17,6.89097216788337e-17)
    sum e = 2.5920011458377283
    sum de = -4.0911691352382706e-19
Info: CFL hydro = 0.01114674064726691 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114674064726691 cfl multiplier : 0.9999999999999988         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9526e+04 |  512 |      1 | 2.622e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1530.8124467838477 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.492011244586386, dt = 0.007988755413613546 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 1360.00 ns (0.5%)
   gen split merge   : 732.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 882.00 ns  (0.3%)
   LB compute        : 274.94 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8149544367407343e-18,-3.234424447023931e-17,2.3540983615580325e-17)
    sum a = (-7.120476083755101e-17,-1.0668419272996665e-16,-5.889819881810254e-18)
    sum e = 2.5920010686925314
    sum de = -2.375080384101058e-18
Info: CFL hydro = 0.011145744663748161 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011145744663748161 cfl multiplier : 0.9999999999999991        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9432e+04 |  512 |      1 | 2.635e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1091.5197061883775 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 1207                                                    [SPH][rank=0]
Info: time since start : 1776.508802003 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.1498863999099041 max=0.15014036383674195 delta=0.0002539639268378524
Number of particle pairs: 130816
Distance min=0.146542 max=1.989321 mean=0.804398
---------------- t = 9.5, dt = 0.011145744663748161 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.45 us    (1.6%)
   patch tree reduce : 1354.00 ns (0.2%)
   gen split merge   : 469.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 885.00 ns  (0.1%)
   LB compute        : 568.07 us  (96.2%)
   LB move op cnt    : 0
   LB apply          : 3.98 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.90 us    (79.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.854691731421724e-21,-3.41738356363086e-17,2.3229953117348545e-17)
    sum a = (-2.60885063552152e-17,-8.342496615396099e-17,-1.3002099397141364e-16)
    sum e = 2.592001119477979
    sum de = 6.471331717022855e-19
Info: CFL hydro = 0.011135610864817423 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011135610864817423 cfl multiplier : 0.9999999999999994        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9159e+04 |  512 |      1 | 2.672e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1501.492983846104 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 9.511145744663748, dt = 0.011135610864817423 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 992.00 ns  (0.3%)
   gen split merge   : 690.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 871.00 ns  (0.3%)
   LB compute        : 279.28 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.46 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5175174445113414e-19,-3.489396271927347e-17,2.105639881205823e-17)
    sum a = (-9.997471600575736e-17,-6.286182512027505e-17,2.7751238806938972e-17)
    sum e = 2.5920011036744945
    sum de = -4.506215279392878e-19
Info: CFL hydro = 0.01112733555259954 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01112733555259954 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9704e+04 |  512 |      1 | 2.598e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.7975294327239 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.522281355528566, dt = 0.01112733555259954 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.4%)
   patch tree reduce : 1591.00 ns (0.5%)
   gen split merge   : 801.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 961.00 ns  (0.3%)
   LB compute        : 277.79 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.3875619403469486e-18,-3.565799999022401e-17,2.2275638365126805e-17)
    sum a = (1.8196381901258717e-17,8.167294965333304e-17,8.231696574378944e-17)
    sum e = 2.5920010923291885
    sum de = -3.8285889215894375e-19
Info: CFL hydro = 0.011121867140487397 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011121867140487397 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9696e+04 |  512 |      1 | 2.600e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1540.9801011154832 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.533408691081165, dt = 0.011121867140487397 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.97 us    (1.3%)
   patch tree reduce : 1315.00 ns (0.4%)
   gen split merge   : 742.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 924.00 ns  (0.3%)
   LB compute        : 289.14 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.0397372946809895e-19,-3.3982094482104543e-17,2.3496341591128233e-17)
    sum a = (-3.025704686798747e-17,-1.0732235412869162e-16,3.545601312548996e-17)
    sum e = 2.592001084999813
    sum de = -9.147955830346444e-19
Info: CFL hydro = 0.01111929189297336 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01111929189297336 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0054e+04 |  512 |      1 | 2.553e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1568.265690932774 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 9.544530558221652, dt = 0.01111929189297336 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.94 us    (1.1%)
   patch tree reduce : 1296.00 ns (0.4%)
   gen split merge   : 931.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 329.57 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.0245710529988016e-18,-3.6193704283649095e-17,2.3686619072399438e-17)
    sum a = (1.5742095127446731e-16,1.5595142364988045e-16,4.42263413391597e-17)
    sum e = 2.5920010822385713
    sum de = -6.301925127571995e-19
Info: CFL hydro = 0.011119658716062405 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011119658716062405 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0392e+04 |  512 |      1 | 2.511e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1594.2732987024156 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.555649850114625, dt = 0.011119658716062405 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.04 us    (1.7%)
   patch tree reduce : 1181.00 ns (0.4%)
   gen split merge   : 832.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 278.07 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.756407519426517e-18,-3.3018997692285665e-17,2.418573154250314e-17)
    sum a = (4.051446678143833e-17,-1.9554670382948556e-17,-7.339441554510273e-17)
    sum e = 2.592001084325694
    sum de = 1.2197274440461925e-19
Info: CFL hydro = 0.011122974054578313 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011122974054578313 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9720e+04 |  512 |      1 | 2.596e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1541.799658716325 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 9.566769508830687, dt = 0.011122974054578313 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 1252.00 ns (0.4%)
   gen split merge   : 881.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 940.00 ns  (0.3%)
   LB compute        : 280.42 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.41 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5456386170953351e-18,-3.4207500113764274e-17,2.2704494534453446e-17)
    sum a = (-9.780848006513132e-17,-6.334190984225163e-17,-5.122269795820866e-17)
    sum e = 2.5920010912368068
    sum de = -1.3417001884508117e-18
Info: CFL hydro = 0.011129203513752907 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011129203513752907 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9647e+04 |  512 |      1 | 2.606e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.5730549843354 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.577892482885265, dt = 0.011129203513752907 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.3%)
   patch tree reduce : 1464.00 ns (0.4%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 940.00 ns  (0.3%)
   LB compute        : 321.95 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (70.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.0491421059976033e-19,-3.52115797457031e-17,2.2249292252335408e-17)
    sum a = (-1.7301785004697479e-16,8.164367619467594e-17,-1.3881766829787478e-16)
    sum e = 2.592001102641318
    sum de = -5.421010862427522e-20
Info: CFL hydro = 0.011137580009372455 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137580009372455 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9397e+04 |  512 |      1 | 2.640e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1517.8612887935294 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.589021686399018, dt = 0.011137580009372455 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.4%)
   patch tree reduce : 1255.00 ns (0.4%)
   gen split merge   : 744.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1269.00 ns (0.4%)
   LB compute        : 293.92 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.696085542319704e-18,-3.3278067801401077e-17,2.0219177894464924e-17)
    sum a = (1.7482109510025268e-16,-4.2856343474007016e-17,1.2353399553299838e-18)
    sum e = 2.5920011179044358
    sum de = -5.827586677109586e-19
Info: CFL hydro = 0.01114746595195813 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114746595195813 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9619e+04 |  512 |      1 | 2.610e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.3700388475563 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.60015926640839, dt = 0.01114746595195813 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1500.00 ns (0.5%)
   gen split merge   : 751.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1001.00 ns (0.3%)
   LB compute        : 285.57 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3465790982269965e-18,-3.4630501591359494e-17,2.1076890233118207e-17)
    sum a = (-2.969499646177098e-17,-3.6966523592196767e-17,-5.202332705248058e-17)
    sum e = 2.592001136123202
    sum de = -2.1819568721270777e-18
Info: CFL hydro = 0.011159961059157031 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011159961059157031 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9597e+04 |  512 |      1 | 2.613e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.0262987003755 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.611306732360347, dt = 0.011159961059157031 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.3%)
   patch tree reduce : 1518.00 ns (0.5%)
   gen split merge   : 849.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 903.00 ns  (0.3%)
   LB compute        : 295.37 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.0444397003392963e-19,-3.4885180681676344e-17,2.017526770647926e-17)
    sum a = (1.6845119049646583e-16,1.0442428172163787e-16,-3.662548779884145e-17)
    sum e = 2.592001156224941
    sum de = 8.876905287225068e-19
Info: CFL hydro = 0.011167386349502742 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011167386349502742 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0221e+04 |  512 |      1 | 2.532e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1586.7013228112103 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.622466693419504, dt = 0.011167386349502742 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.96 us    (1.3%)
   patch tree reduce : 1658.00 ns (0.5%)
   gen split merge   : 723.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 956.00 ns  (0.3%)
   LB compute        : 293.05 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.7077949257825475e-18,-3.318732007956404e-17,1.9837159258989655e-17)
    sum a = (-8.430756093247282e-19,7.792594694522315e-17,2.241761463961378e-17)
    sum e = 2.5920011767729965
    sum de = -6.369687763352339e-19
Info: CFL hydro = 0.011172633423791541 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011172633423791541 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9255e+04 |  512 |      1 | 2.659e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1511.9254027304694 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.633634079769006, dt = 0.011172633423791541 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1181.00 ns (0.4%)
   gen split merge   : 720.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1457.00 ns (0.5%)
   LB compute        : 274.31 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8530099329949757e-18,-3.229155224465652e-17,2.039628231934043e-17)
    sum a = (4.688437138522517e-17,-1.0272642111952557e-16,7.339148819923702e-17)
    sum e = 2.5920011964737393
    sum de = -1.0977546996415732e-18
Info: CFL hydro = 0.011178497084600348 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011178497084600348 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9708e+04 |  512 |      1 | 2.598e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1548.2017819158036 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.644806713192798, dt = 0.011178497084600348 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.4%)
   patch tree reduce : 1299.00 ns (0.4%)
   gen split merge   : 763.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 941.00 ns  (0.3%)
   LB compute        : 293.66 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.32 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.672666775394017e-18,-3.447827960634253e-17,2.144427213926492e-17)
    sum a = (-4.5561211053923857e-17,-2.110030900004389e-17,1.6848046395512296e-16)
    sum e = 2.592001214143204
    sum de = -6.369687763352339e-19
Info: CFL hydro = 0.011184529765576047 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011184529765576047 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0109e+04 |  512 |      1 | 2.546e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1580.5256230965151 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.655985210277398, dt = 0.011184529765576047 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.4%)
   patch tree reduce : 1370.00 ns (0.4%)
   gen split merge   : 824.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 859.00 ns  (0.3%)
   LB compute        : 304.67 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3817072486155268e-18,-3.416798094457718e-17,2.393251612511915e-17)
    sum a = (1.3851029698197514e-16,-1.0269129296913703e-17,6.771536456562366e-17)
    sum e = 2.592001228631752
    sum de = -1.3213713977167085e-19
Info: CFL hydro = 0.0111904429747645 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0111904429747645 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0118e+04 |  512 |      1 | 2.545e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1582.1149118919434 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.667169740042974, dt = 0.0111904429747645 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.5%)
   patch tree reduce : 1772.00 ns (0.6%)
   gen split merge   : 670.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 883.00 ns  (0.3%)
   LB compute        : 276.53 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1934.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.0426646405467e-18,-3.4416805343162607e-17,2.4087665456001828e-17)
    sum a = (9.258609504070314e-17,7.590022360615123e-17,-1.0856940346748445e-16)
    sum e = 2.592001238979854
    sum de = 1.1485766764768313e-18
Info: CFL hydro = 0.011196737716457699 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011196737716457699 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0243e+04 |  512 |      1 | 2.529e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1592.8134200784282 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.67836018301774, dt = 0.011196737716457699 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.4%)
   patch tree reduce : 1186.00 ns (0.4%)
   gen split merge   : 811.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 895.00 ns  (0.3%)
   LB compute        : 278.00 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.63 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1941.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.885740249871429e-18,-3.3160973966772644e-17,2.1808726699545922e-17)
    sum a = (-8.825947785118248e-17,7.786740002790892e-18,2.1849709541665873e-17)
    sum e = 2.592001244562919
    sum de = -1.7313353441877899e-18
Info: CFL hydro = 0.011190841650790831 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011190841650790831 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9835e+04 |  512 |      1 | 2.581e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1561.542800511218 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 9.689556920734198, dt = 0.011190841650790831 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1017.00 ns (0.4%)
   gen split merge   : 756.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 273.97 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1919.00 ns (64.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.8717262942623554e-18,-3.332197798938674e-17,2.2883062632261808e-17)
    sum a = (9.707664359870361e-17,1.1966989899026004e-16,8.763302583592036e-17)
    sum e = 2.592001244597774
    sum de = 5.116079001415974e-19
Info: CFL hydro = 0.011173494534609342 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011173494534609342 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9826e+04 |  512 |      1 | 2.583e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1559.9892594370913 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.700747762384989, dt = 0.011173494534609342 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.5%)
   patch tree reduce : 1426.00 ns (0.5%)
   gen split merge   : 653.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 987.00 ns  (0.3%)
   LB compute        : 274.32 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (64.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.1023638439340324e-18,-3.1331382800703355e-17,2.41740221590403e-17)
    sum a = (-5.058234105008441e-17,-3.2786273695961654e-19,-3.8599982585263425e-17)
    sum e = 2.592001239155207
    sum de = 1.539905898108318e-18
Info: CFL hydro = 0.011156942851394102 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011156942851394102 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9461e+04 |  512 |      1 | 2.631e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.8911493247413 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.711921256919599, dt = 0.011156942851394102 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.78 us    (1.5%)
   patch tree reduce : 1434.00 ns (0.4%)
   gen split merge   : 824.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 926.00 ns  (0.3%)
   LB compute        : 302.26 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1908.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.711874557721373e-18,-3.192270666557695e-17,2.2963564643568857e-17)
    sum a = (-4.212157966171359e-17,7.270941661252639e-17,5.561957144850638e-19)
    sum e = 2.592001229132479
    sum de = 1.2265037076242269e-18
Info: CFL hydro = 0.011141449362575039 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011141449362575039 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9269e+04 |  512 |      1 | 2.657e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1511.5758260215966 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.723078199770994, dt = 0.011141449362575039 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.4%)
   patch tree reduce : 1199.00 ns (0.4%)
   gen split merge   : 621.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 925.00 ns  (0.3%)
   LB compute        : 279.06 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1968.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.3605930538360694e-18,-3.0807387890741114e-17,2.3232880463214254e-17)
    sum a = (-3.8933700013954467e-17,-1.1809205956864187e-16,-2.3008938504487375e-17)
    sum e = 2.592001215323832
    sum de = 9.037841547203385e-19
Info: CFL hydro = 0.011127262476634512 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011127262476634512 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9935e+04 |  512 |      1 | 2.568e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1561.663641665459 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 9.73421964913357, dt = 0.011127262476634512 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.3%)
   patch tree reduce : 1105.00 ns (0.3%)
   gen split merge   : 662.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 306.94 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.0737131589964052e-18,-3.3038025440412786e-17,2.2858180192403265e-17)
    sum a = (-1.430828112242155e-16,-4.1691259819454095e-17,4.60588598510947e-17)
    sum e = 2.5920011987282283
    sum de = 1.957493141104688e-18
Info: CFL hydro = 0.01111459698740525 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01111459698740525 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9963e+04 |  512 |      1 | 2.565e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1561.903301850553 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 9.745346911610204, dt = 0.01111459698740525 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.70 us    (1.6%)
   patch tree reduce : 1311.00 ns (0.4%)
   gen split merge   : 659.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1348.00 ns (0.5%)
   LB compute        : 276.55 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1864.00 ns (64.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.786740002790892e-19,-3.308779032012987e-17,2.3809567598759296e-17)
    sum a = (-1.2077058103576733e-16,-3.378596230910191e-17,-7.306069811641169e-17)
    sum e = 2.592001180536947
    sum de = 2.9180285032910647e-19
Info: CFL hydro = 0.011103651228885889 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011103651228885889 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9942e+04 |  512 |      1 | 2.567e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1558.4811986795896 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.756461508597608, dt = 0.011103651228885889 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1635.00 ns (0.5%)
   gen split merge   : 794.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 950.00 ns  (0.3%)
   LB compute        : 287.80 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1868.00 ns (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.269222558279552e-19,-3.335125144804385e-17,2.2331257936575312e-17)
    sum a = (-3.4086015260337274e-17,-7.536927624975792e-17,-5.4963845974587144e-17)
    sum e = 2.5920011620150456
    sum de = 2.795208725939191e-20
Info: CFL hydro = 0.011094599907637436 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011094599907637436 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9952e+04 |  512 |      1 | 2.566e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1557.7381217583543 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.767565159826495, dt = 0.011094599907637436 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.6%)
   patch tree reduce : 1371.00 ns (0.5%)
   gen split merge   : 626.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 859.00 ns  (0.3%)
   LB compute        : 271.04 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.620504062164855e-19,-3.451048041086535e-17,2.177067120329168e-17)
    sum a = (3.317268335023549e-17,4.797919873900103e-18,5.234094407891021e-18)
    sum e = 2.5920011444317583
    sum de = 1.2400562347802957e-18
Info: CFL hydro = 0.011087587057885864 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011087587057885864 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9778e+04 |  512 |      1 | 2.589e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.891757673848 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 9.778659759734133, dt = 0.011087587057885864 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.3%)
   patch tree reduce : 1064.00 ns (0.4%)
   gen split merge   : 615.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 862.00 ns  (0.3%)
   LB compute        : 285.86 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.132260076310622e-19,-3.4103579335531543e-17,2.222221430307758e-17)
    sum a = (1.2100476870502418e-16,-9.502164680097458e-17,-5.362897625982299e-18)
    sum e = 2.592001128972058
    sum de = -5.709002064493984e-19
Info: CFL hydro = 0.011082727204994652 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011082727204994652 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9875e+04 |  512 |      1 | 2.576e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1549.4453738865636 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.78974734679202, dt = 0.011082727204994652 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.77 us    (1.3%)
   patch tree reduce : 1422.00 ns (0.5%)
   gen split merge   : 668.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 921.00 ns  (0.3%)
   LB compute        : 277.77 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0959796398489773e-18,-3.566092733608972e-17,2.2089020066187738e-17)
    sum a = (1.2037246199803065e-16,-2.957204793541113e-17,3.0412196198870143e-17)
    sum e = 2.5920011166710597
    sum de = -8.843023969334896e-19
Info: CFL hydro = 0.011080104387415038 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011080104387415038 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9805e+04 |  512 |      1 | 2.585e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1543.2849118158128 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.800830073997014, dt = 0.011080104387415038 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.5%)
   patch tree reduce : 1446.00 ns (0.5%)
   gen split merge   : 635.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1103.00 ns (0.4%)
   LB compute        : 289.61 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.3869391666274674e-18,-3.56550726443583e-17,2.2613746812616407e-17)
    sum a = (1.1614537456794415e-16,-1.3167201703967457e-17,8.865466954305345e-17)
    sum e = 2.592001108344268
    sum de = 1.6940658945086007e-18
Info: CFL hydro = 0.011079771354017531 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011079771354017531 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9452e+04 |  512 |      1 | 2.632e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1515.471922685754 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 9.81191017838443, dt = 0.011079771354017531 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.08 us    (1.3%)
   patch tree reduce : 1730.00 ns (0.5%)
   gen split merge   : 677.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 301.13 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.6369158512860054e-18,-3.56550726443583e-17,2.3928856942787012e-17)
    sum a = (-2.7189188400722487e-17,-4.100040619514633e-17,4.288122591386556e-17)
    sum e = 2.5920011045361067
    sum de = 3.049318610115481e-20
Info: CFL hydro = 0.011080041804915727 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011080041804915727 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9855e+04 |  512 |      1 | 2.579e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1546.8040171688826 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.822989949738448, dt = 0.011080041804915727 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1209.00 ns (0.4%)
   gen split merge   : 728.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 950.00 ns  (0.3%)
   LB compute        : 286.30 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (63.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.547943189241564e-18,-3.626103323856045e-17,2.4100106675931097e-17)
    sum a = (5.127539018379146e-17,3.114696001116357e-18,-1.4285667375608934e-16)
    sum e = 2.592001105468031
    sum de = 6.098637220230962e-20
Info: CFL hydro = 0.011082094014864026 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011082094014864026 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9712e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1535.701242312345 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 9.834069991543362, dt = 0.011082094014864026 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.4%)
   patch tree reduce : 1479.00 ns (0.5%)
   gen split merge   : 639.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1077.00 ns (0.3%)
   LB compute        : 293.13 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.537386091851836e-18,-3.59800080354522e-17,2.1601616979546877e-17)
    sum a = (1.8722133218740388e-16,5.639239075705405e-17,-2.3171955077384147e-17)
    sum e = 2.5920011110832335
    sum de = 1.3078188705606397e-18
Info: CFL hydro = 0.01108648580827906 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01108648580827906 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9791e+04 |  512 |      1 | 2.587e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.1289268678754 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.845152085558226, dt = 0.01108648580827906 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.5%)
   patch tree reduce : 1551.00 ns (0.5%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 968.00 ns  (0.3%)
   LB compute        : 279.23 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1960.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.406185040248481e-18,-3.501398389976762e-17,2.193460257177149e-17)
    sum a = (-5.312547277092072e-17,8.242235019495503e-17,-9.409587367094352e-17)
    sum e = 2.592001121005318
    sum de = 1.0401564592282808e-18
Info: CFL hydro = 0.011093180239406008 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011093180239406008 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9656e+04 |  512 |      1 | 2.605e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1532.2588678953252 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.856238571366505, dt = 0.011093180239406008 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1835.00 ns (0.6%)
   gen split merge   : 664.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 897.00 ns  (0.3%)
   LB compute        : 273.62 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.380461701176564e-18,-3.392501123772318e-17,2.0533135738562413e-17)
    sum a = (-2.098321516541546e-17,8.607567783536219e-17,2.029675255990626e-17)
    sum e = 2.5920011345739824
    sum de = -1.5551524911588954e-18
Info: CFL hydro = 0.011102107193251807 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011102107193251807 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0134e+04 |  512 |      1 | 2.543e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1570.3923192639386 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.867331751605912, dt = 0.011102107193251807 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1066.00 ns (0.4%)
   gen split merge   : 677.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 282.76 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1943.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.351188242519456e-18,-3.2953132410307176e-17,2.139231175014855e-17)
    sum a = (-1.7950484848539005e-17,2.4613124038896926e-17,3.280969246288734e-17)
    sum e = 2.5920011508914147
    sum de = -1.1468826105823227e-18
Info: CFL hydro = 0.011113162377966241 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011113162377966241 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9993e+04 |  512 |      1 | 2.561e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1560.6520544199677 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.878433858799164, dt = 0.011113162377966241 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.76 us    (1.3%)
   patch tree reduce : 1126.00 ns (0.4%)
   gen split merge   : 641.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 778.00 ns  (0.3%)
   LB compute        : 277.63 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.63 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1823.00 ns (64.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.239949099622443e-18,-3.304973482387563e-17,2.1794821806683795e-17)
    sum a = (7.423749115442746e-17,-7.09588637848313e-17,-2.394276183564914e-17)
    sum e = 2.592001168883272
    sum de = 3.015437292225309e-19
Info: CFL hydro = 0.011117405048752704 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011117405048752704 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9348e+04 |  512 |      1 | 2.646e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1511.8250153026445 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.889547021177131, dt = 0.011117405048752704 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.5%)
   patch tree reduce : 1194.00 ns (0.4%)
   gen split merge   : 652.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 869.00 ns  (0.3%)
   LB compute        : 275.32 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.51 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.5631094309237524e-18,-3.4463642877013976e-17,2.1267167714389412e-17)
    sum a = (1.0976376058069447e-16,-8.520918345911176e-17,6.561060288817754e-17)
    sum e = 2.5920011871528224
    sum de = 3.7269449679189215e-20
Info: CFL hydro = 0.011109949566618097 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011109949566618097 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9853e+04 |  512 |      1 | 2.579e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1551.8869966094462 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.900664426225884, dt = 0.011109949566618097 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 1076.00 ns (0.4%)
   gen split merge   : 659.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1379.00 ns (0.5%)
   LB compute        : 275.63 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1822.00 ns (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.839432228373688e-18,-3.5467722508952804e-17,2.2509826034383673e-17)
    sum a = (2.0775959078123129e-16,-8.358157915777653e-17,-1.2976924222696252e-16)
    sum e = 2.5920012042719693
    sum de = 2.0328790734103208e-20
Info: CFL hydro = 0.011103788355482104 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011103788355482104 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0011e+04 |  512 |      1 | 2.559e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1563.1940330954626 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.911774375792502, dt = 0.011103788355482104 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1471.00 ns (0.5%)
   gen split merge   : 639.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 806.00 ns  (0.3%)
   LB compute        : 286.95 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1754.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0673103026381802e-17,-3.64235009341074e-17,1.997986736994306e-17)
    sum a = (7.814842523101717e-17,1.3319423688984422e-16,1.0574451470707347e-16)
    sum e = 2.592001219372561
    sum de = -3.1594328932585403e-19
Info: CFL hydro = 0.011099058458784561 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011099058458784561 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9916e+04 |  512 |      1 | 2.571e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1554.8904996837823 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.922878164147985, dt = 0.011099058458784561 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.02 us    (1.3%)
   patch tree reduce : 998.00 ns  (0.3%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 905.00 ns  (0.3%)
   LB compute        : 298.75 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1965.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0737504635427442e-17,-3.375229783164624e-17,2.2531781128376503e-17)
    sum a = (6.194263851844184e-18,-1.0648513321109832e-16,6.612288841467695e-17)
    sum e = 2.592001231494419
    sum de = 8.080694316806025e-19
Info: CFL hydro = 0.011095881377547053 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011095881377547053 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0010e+04 |  512 |      1 | 2.559e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1561.6067612375234 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.933977222606769, dt = 0.011095881377547053 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 1619.00 ns (0.6%)
   gen split merge   : 739.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 843.00 ns  (0.3%)
   LB compute        : 272.56 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.68 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1827.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0450624740587777e-17,-3.624054181750047e-17,2.3001620139823098e-17)
    sum a = (-8.29258536838573e-17,-7.447167882368433e-17,-6.238174039829847e-18)
    sum e = 2.592001239932924
    sum de = 3.263194429297192e-19
Info: CFL hydro = 0.0110943384495872 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0110943384495872 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9930e+04 |  512 |      1 | 2.569e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1554.8942623606704 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.945073103984317, dt = 0.0110943384495872 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.65 us    (1.3%)
   patch tree reduce : 1018.00 ns (0.4%)
   gen split merge   : 725.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 766.00 ns  (0.3%)
   LB compute        : 269.84 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.61 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1838.00 ns (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.057208108509407e-18,-3.68406477199712e-17,2.253324480130936e-17)
    sum a = (-1.7376725058859676e-17,-1.6663623605972512e-16,-1.1587313140243305e-16)
    sum e = 2.5920012441996376
    sum de = 2.9095581738185217e-19
Info: CFL hydro = 0.011094504928400266 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011094504928400266 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9975e+04 |  512 |      1 | 2.563e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1558.2165209949412 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.956167442433904, dt = 0.011094504928400266 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.61 us    (1.3%)
   patch tree reduce : 1319.00 ns (0.5%)
   gen split merge   : 652.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 875.00 ns  (0.3%)
   LB compute        : 268.99 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.59 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1937.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.168447251406419e-18,-3.9205943179465573e-17,2.0589487146477346e-17)
    sum a = (1.8816979224789422e-17,1.124100812432971e-18,5.820588152086193e-17)
    sum e = 2.59200124411281
    sum de = 2.0074680849926918e-19
Info: CFL hydro = 0.01109644819268781 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01109644819268781 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9931e+04 |  512 |      1 | 2.569e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1554.7566923070735 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.967261947362303, dt = 0.01109644819268781 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.67 us    (1.3%)
   patch tree reduce : 1017.00 ns (0.4%)
   gen split merge   : 947.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 804.00 ns  (0.3%)
   LB compute        : 270.26 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.67 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.478745913171771e-18,-3.840970510399222e-17,2.226685632752967e-17)
    sum a = (-3.3945502658783154e-17,-6.669664820435628e-17,2.3970571621373392e-17)
    sum e = 2.592001239802398
    sum de = -3.3881317890172014e-21
Info: CFL hydro = 0.011100176602511154 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011100176602511154 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0154e+04 |  512 |      1 | 2.540e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1572.4511237148004 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.978358395554991, dt = 0.011100176602511154 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.77 us    (1.3%)
   patch tree reduce : 1045.00 ns (0.4%)
   gen split merge   : 638.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 873.00 ns  (0.3%)
   LB compute        : 271.48 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1991.00 ns (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.951823657343816e-18,-3.943427615699102e-17,2.2316621207246755e-17)
    sum a = (-6.035601705922656e-17,-4.786795959610402e-17,7.826728004714294e-17)
    sum e = 2.5920012316522962
    sum de = -1.5136478767434347e-18
Info: CFL hydro = 0.011105678158890171 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011105678158890171 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9949e+04 |  512 |      1 | 2.566e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1557.0130562600787 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 9.989458572157503, dt = 0.010541427842497342 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 852.00 ns  (0.3%)
   gen split merge   : 675.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1193.00 ns (0.4%)
   LB compute        : 270.77 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.138021506676197e-18,-3.9718228705964977e-17,2.3499268936993945e-17)
    sum a = (6.924343910752473e-17,-9.723472027545199e-17,-3.4222136843092834e-17)
    sum e = 2.5920012044753036
    sum de = -8.080694316806025e-19
Info: CFL hydro = 0.011112597580273841 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011112597580273841 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0238e+04 |  512 |      1 | 2.530e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1500.0250101927104 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 1252                                                    [SPH][rank=0]
Info: time since start : 1778.2983770540002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.1498468898525025 max=0.15014583001685397 delta=0.0002989401643514744
Number of particle pairs: 130816
Distance min=0.145231 max=1.986928 mean=0.803875
---------------- t = 10, dt = 0.011112597580273841 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.92 us    (1.5%)
   patch tree reduce : 1644.00 ns (0.2%)
   gen split merge   : 416.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 775.00 ns  (0.1%)
   LB compute        : 634.05 us  (96.0%)
   LB move op cnt    : 0
   LB apply          : 6.44 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.13 us    (80.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.566566289143097e-18,-4.142706685507369e-17,2.248494359452513e-17)
    sum a = (1.4751481286490176e-16,1.756407519426517e-18,1.711911862267712e-17)
    sum e = 2.5920012078815424
    sum de = -1.3383120566617945e-19
Info: CFL hydro = 0.01111473534619301 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01111473534619301 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7666e+04 |  512 |      1 | 2.898e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1380.342259387231 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 10.011112597580274, dt = 0.01111473534619301 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.90 us    (1.3%)
   patch tree reduce : 1493.00 ns (0.5%)
   gen split merge   : 1090.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 760.00 ns  (0.3%)
   LB compute        : 272.56 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.42 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.16157083951407e-17,-4.08964854169136e-17,2.304845767367447e-17)
    sum a = (-6.146548114233097e-17,2.964815892791961e-17,2.4059855670277576e-17)
    sum e = 2.59200119273916
    sum de = 1.3349239248727773e-18
Info: CFL hydro = 0.011111983273321416 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011111983273321416 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9692e+04 |  512 |      1 | 2.600e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1538.947492629493 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 10.022227332926468, dt = 0.011111983273321416 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.42 us    (1.2%)
   patch tree reduce : 1068.00 ns (0.4%)
   gen split merge   : 1076.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 819.00 ns  (0.3%)
   LB compute        : 269.69 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.45 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.777335191474278e-18,-4.0327848482499263e-17,2.3197752312825726e-17)
    sum a = (-9.44069041691753e-18,9.11458408747734e-17,5.121684326647724e-17)
    sum e = 2.592001177458069
    sum de = 4.777265822514254e-19
Info: CFL hydro = 0.011111521485620168 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011111521485620168 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9466e+04 |  512 |      1 | 2.630e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1520.886376918114 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 10.03333931619979, dt = 0.011111521485620168 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.5%)
   patch tree reduce : 1295.00 ns (0.4%)
   gen split merge   : 637.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1141.00 ns (0.4%)
   LB compute        : 276.96 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1983.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.911993101296978e-18,-3.878440537480321e-17,2.3924465923988448e-17)
    sum a = (1.3907820207992304e-17,-3.531550052393584e-17,-5.537952908751809e-17)
    sum e = 2.5920011631395825
    sum de = 7.843525091574821e-19
Info: CFL hydro = 0.011113363892023727 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011113363892023727 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9176e+04 |  512 |      1 | 2.670e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1498.2038827453287 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.04445083768541, dt = 0.011113363892023727 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.3%)
   patch tree reduce : 1292.00 ns (0.4%)
   gen split merge   : 1093.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 318.53 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (70.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0175454229210957e-17,-3.991216536956832e-17,2.2723522282580567e-17)
    sum a = (3.425141030174994e-17,1.158058024475217e-17,-1.5346317966402624e-16)
    sum e = 2.592001150772606
    sum de = -2.710505431213761e-19
Info: CFL hydro = 0.011117494079035397 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011117494079035397 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9334e+04 |  512 |      1 | 2.648e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.7886017372516 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.055564201577434, dt = 0.011117494079035397 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.85 us    (1.3%)
   patch tree reduce : 1230.00 ns (0.4%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 977.00 ns  (0.3%)
   LB compute        : 276.36 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1909.00 ns (64.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0719940560233176e-17,-3.9556858765117663e-17,2.0405064356937562e-17)
    sum a = (-1.6036000652364103e-17,-6.686057957283609e-18,5.396854838024545e-17)
    sum e = 2.5920011412037987
    sum de = -2.414043899674756e-19
Info: CFL hydro = 0.01112386282033353 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01112386282033353 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0092e+04 |  512 |      1 | 2.548e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1570.5626219759913 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.06668169565647, dt = 0.01112386282033353 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.72 us    (1.3%)
   patch tree reduce : 1114.00 ns (0.4%)
   gen split merge   : 939.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 751.00 ns  (0.3%)
   LB compute        : 282.46 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.31 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1821.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0345240289422185e-17,-3.9821417647731285e-17,2.2271979182794666e-17)
    sum a = (-7.215907558977275e-19,-7.11227951533111e-17,4.153318314270571e-17)
    sum e = 2.5920011350757286
    sum de = 2.829090043829363e-19
Info: CFL hydro = 0.011129631534457967 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011129631534457967 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0259e+04 |  512 |      1 | 2.527e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1584.57609258197 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 10.077805558476804, dt = 0.011129631534457967 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.4%)
   patch tree reduce : 872.00 ns  (0.3%)
   gen split merge   : 663.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 814.00 ns  (0.3%)
   LB compute        : 274.68 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0298402755570813e-17,-4.098137844701921e-17,2.2589596209224294e-17)
    sum a = (4.275223973665768e-17,-1.4413080104414e-16,-2.2329794263642454e-17)
    sum e = 2.592001132740707
    sum de = 8.521151449378261e-19
Info: CFL hydro = 0.01113104032322508 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01113104032322508 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9925e+04 |  512 |      1 | 2.570e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1559.2589797073122 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.088935190011261, dt = 0.01113104032322508 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1395.00 ns (0.5%)
   gen split merge   : 1029.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 871.00 ns  (0.3%)
   LB compute        : 283.73 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.56 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.100682045507284e-17,-4.290958457693963e-17,2.199168581615285e-17)
    sum a = (-4.832755289702062e-17,4.876665477687725e-17,5.50341022753642e-19)
    sum e = 2.592001134272926
    sum de = 2.7253285077907113e-19
Info: CFL hydro = 0.011134629513999867 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011134629513999867 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0089e+04 |  512 |      1 | 2.549e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1572.2296912086365 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.100066230334486, dt = 0.011134629513999867 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.64 us    (1.3%)
   patch tree reduce : 1062.00 ns (0.4%)
   gen split merge   : 655.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 729.00 ns  (0.3%)
   LB compute        : 268.54 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.65 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1840.00 ns (12.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0005668168999726e-17,-4.118245051617023e-17,2.214537147410267e-17)
    sum a = (-2.8458924669974574e-17,-5.897284613767817e-17,-4.289147162439555e-17)
    sum e = 2.592001139602405
    sum de = 1.2680083220396876e-18
Info: CFL hydro = 0.011140317105749954 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011140317105749954 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0261e+04 |  512 |      1 | 2.527e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1586.2424150942488 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.111200859848486, dt = 0.011140317105749954 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.97 us    (1.4%)
   patch tree reduce : 928.00 ns  (0.3%)
   gen split merge   : 631.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 704.00 ns  (0.2%)
   LB compute        : 275.73 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.41 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1943.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.888574334371292e-18,-4.2505244929238325e-17,2.1305223210643653e-17)
    sum a = (2.7709524128352593e-17,-1.1063885403542542e-16,-6.640391361778519e-17)
    sum e = 2.5920011483071588
    sum de = -1.1231656880592022e-18
Info: CFL hydro = 0.011147992777894349 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011147992777894349 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0032e+04 |  512 |      1 | 2.556e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1569.1168218002056 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.122341176954237, dt = 0.011147992777894349 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.97 us    (1.3%)
   patch tree reduce : 956.00 ns  (0.3%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 708.00 ns  (0.2%)
   LB compute        : 299.88 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 2.70 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0315966830765077e-17,-4.404996875075062e-17,2.0554885003549062e-17)
    sum a = (-4.3523778331389093e-17,-2.3605897510152464e-16,4.019831342794156e-17)
    sum e = 2.592001159744499
    sum de = 3.7100043089738355e-19
Info: CFL hydro = 0.011157516716447324 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011157516716447324 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0172e+04 |  512 |      1 | 2.538e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1581.1466748601013 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.133489169732131, dt = 0.011157516716447324 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.78 us    (1.2%)
   patch tree reduce : 1440.00 ns (0.5%)
   gen split merge   : 661.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 876.00 ns  (0.3%)
   LB compute        : 289.68 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.43 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1864.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.537292830485988e-18,-4.7436176080911663e-17,2.159612820604867e-17)
    sum a = (-1.7520896842745936e-16,-8.834729822715382e-18,4.156831129309424e-17)
    sum e = 2.5920011731000363
    sum de = 1.5585406229479126e-19
Info: CFL hydro = 0.011161098572772797 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011161098572772797 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0264e+04 |  512 |      1 | 2.527e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1589.711474120669 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 10.14464668644858, dt = 0.011161098572772797 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.5%)
   patch tree reduce : 1350.00 ns (0.5%)
   gen split merge   : 679.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 871.00 ns  (0.3%)
   LB compute        : 270.04 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.40 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1776.00 ns (64.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.96122846866043e-18,-4.6201202043814893e-17,2.2030473148873518e-17)
    sum a = (6.134399628890397e-17,-6.287060715787218e-17,-2.2364922414030986e-18)
    sum e = 2.592001187285481
    sum de = -3.9641141931501256e-19
Info: CFL hydro = 0.011155039375733877 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011155039375733877 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9868e+04 |  512 |      1 | 2.577e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1559.14291520403 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 10.155807785021352, dt = 0.011155039375733877 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.4%)
   patch tree reduce : 1354.00 ns (0.4%)
   gen split merge   : 636.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 877.00 ns  (0.3%)
   LB compute        : 291.76 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.61 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.770328213669742e-18,-4.707940580352815e-17,2.1697487556648908e-17)
    sum a = (-7.519034223371635e-17,-2.5110772836067773e-17,-1.0429547850354659e-16)
    sum e = 2.5920012011766183
    sum de = 9.452887691357992e-19
Info: CFL hydro = 0.011149827062146025 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011149827062146025 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0335e+04 |  512 |      1 | 2.518e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1594.9673335353327 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.166962824397086, dt = 0.011149827062146025 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.4%)
   patch tree reduce : 1157.00 ns (0.4%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 824.00 ns  (0.3%)
   LB compute        : 266.75 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1926.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.412039731979903e-18,-4.730883653575324e-17,1.996669431354736e-17)
    sum a = (3.1004983736676596e-17,1.9724456443159787e-17,-1.6697580818014758e-17)
    sum e = 2.592001214025288
    sum de = 8.470329472543003e-19
Info: CFL hydro = 0.01114554456564652 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114554456564652 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0161e+04 |  512 |      1 | 2.540e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1580.562630105109 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 10.178112651459232, dt = 0.01114554456564652 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.87 us    (1.3%)
   patch tree reduce : 1608.00 ns (0.5%)
   gen split merge   : 633.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 952.00 ns  (0.3%)
   LB compute        : 285.34 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.260970033036053e-18,-4.667543207406005e-17,2.0270406447114864e-17)
    sum a = (-9.146931259293444e-17,4.2095233548922194e-17,3.7001651742585295e-18)
    sum e = 2.5920012250257303
    sum de = -3.7269449679189215e-20
Info: CFL hydro = 0.011142264234961405 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011142264234961405 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0182e+04 |  512 |      1 | 2.537e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1581.5694722075261 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.189258196024879, dt = 0.011142264234961405 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.5%)
   patch tree reduce : 1570.00 ns (0.6%)
   gen split merge   : 636.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 837.00 ns  (0.3%)
   LB compute        : 267.70 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.545545355729487e-18,-4.603544108416901e-17,2.0452633727255364e-17)
    sum a = (-2.6006540670975297e-17,4.931406845376518e-17,7.698919626819567e-17)
    sum e = 2.59200123352423
    sum de = -1.1587410718438829e-18
Info: CFL hydro = 0.01114004546584073 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114004546584073 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9847e+04 |  512 |      1 | 2.580e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1554.9023292226982 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.20040046025984, dt = 0.01114004546584073 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.78 us    (1.6%)
   patch tree reduce : 1383.00 ns (0.5%)
   gen split merge   : 636.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1194.00 ns (0.4%)
   LB compute        : 286.35 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.375759295518257e-18,-4.5645372247563044e-17,2.18028720078145e-17)
    sum a = (1.4421496223777918e-16,-2.4665816264479724e-17,-5.546734946348941e-17)
    sum e = 2.5920012390623772
    sum de = -6.132518538121134e-19
Info: CFL hydro = 0.011138934604846641 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011138934604846641 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0602e+04 |  512 |      1 | 2.485e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1613.7419106316654 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.21154050572568, dt = 0.011138934604846641 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.83 us    (1.4%)
   patch tree reduce : 1336.00 ns (0.5%)
   gen split merge   : 815.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 748.00 ns  (0.3%)
   LB compute        : 263.21 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.71 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1875.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.057208108509407e-18,-4.619059041505169e-17,2.04694659659832e-17)
    sum a = (-1.5411670962854618e-16,1.406296953887498e-16,4.0385663563347054e-17)
    sum e = 2.5920012414202533
    sum de = 4.675621868843738e-19
Info: CFL hydro = 0.01113551225740481 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01113551225740481 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9382e+04 |  512 |      1 | 2.642e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.0417605686941 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.222679440330525, dt = 0.01113551225740481 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.4%)
   patch tree reduce : 1892.00 ns (0.6%)
   gen split merge   : 892.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 903.00 ns  (0.3%)
   LB compute        : 293.01 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.6439228290905416e-18,-4.3796753333366635e-17,2.1435490101667788e-17)
    sum a = (-3.9948757192889704e-17,-9.180156634869263e-17,2.989405598063932e-17)
    sum e = 2.5920012405592017
    sum de = -8.538092108323347e-19
Info: CFL hydro = 0.011127552185980908 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011127552185980908 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9533e+04 |  512 |      1 | 2.621e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.389341267662 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 10.23381495258793, dt = 0.011127552185980908 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.4%)
   patch tree reduce : 1138.00 ns (0.4%)
   gen split merge   : 1014.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 859.00 ns  (0.3%)
   LB compute        : 297.91 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.907383957004519e-18,-4.6144484717666746e-17,2.1701878575447476e-17)
    sum a = (5.964833119619095e-18,1.308991977311269e-16,9.848176961424481e-17)
    sum e = 2.5920012366746192
    sum de = 1.8973538018496328e-19
Info: CFL hydro = 0.011121217463498815 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011121217463498815 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9754e+04 |  512 |      1 | 2.592e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1545.5483358447884 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.24494250477391, dt = 0.011121217463498815 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.4%)
   patch tree reduce : 1276.00 ns (0.4%)
   gen split merge   : 646.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1278.00 ns (0.4%)
   LB compute        : 279.31 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (64.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.446015596295318e-18,-4.344254448361562e-17,2.3200679658691435e-17)
    sum a = (-1.1082272794761539e-16,-1.3951730395977967e-17,-1.0058360394582522e-17)
    sum e = 2.592001230440256
    sum de = 9.622294280808852e-19
Info: CFL hydro = 0.011116628892220978 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011116628892220978 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0016e+04 |  512 |      1 | 2.558e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1565.172732594998 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 10.256063722237409, dt = 0.011116628892220978 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.74 us    (1.3%)
   patch tree reduce : 1338.00 ns (0.5%)
   gen split merge   : 644.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 891.00 ns  (0.3%)
   LB compute        : 271.92 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (64.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.303198422594967e-18,-4.4481752265942975e-17,2.2460061154666588e-17)
    sum a = (-3.8541069749716e-17,-7.511569491414071e-18,-5.354701057558309e-17)
    sum e = 2.5920012224957083
    sum de = 5.759824041329242e-19
Info: CFL hydro = 0.011113883631664627 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011113883631664627 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0018e+04 |  512 |      1 | 2.558e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1564.6741821586236 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.26718035112963, dt = 0.011113883631664627 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.6%)
   patch tree reduce : 1547.00 ns (0.5%)
   gen split merge   : 668.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 865.00 ns  (0.3%)
   LB compute        : 272.77 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (64.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.227087430086485e-18,-4.441076412869949e-17,2.1515992112974834e-17)
    sum a = (-1.2041746994071595e-16,-5.373436071098858e-17,2.4787667036139938e-17)
    sum e = 2.592001213576422
    sum de = -1.4907779871675686e-19
Info: CFL hydro = 0.01110453674227107 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01110453674227107 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9896e+04 |  512 |      1 | 2.573e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1554.7353594742456 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.278294234761294, dt = 0.01110453674227107 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.89 us    (1.4%)
   patch tree reduce : 1165.00 ns (0.4%)
   gen split merge   : 639.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 926.00 ns  (0.3%)
   LB compute        : 271.77 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (63.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.417987685077172e-18,-4.539581601251119e-17,2.2319548553112468e-17)
    sum a = (-9.383826723476097e-17,-3.895126408914873e-17,1.0659637235399533e-16)
    sum e = 2.5920012042604914
    sum de = 1.1045309632196076e-18
Info: CFL hydro = 0.01109564315326069 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01109564315326069 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9578e+04 |  512 |      1 | 2.615e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.6367607920872 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.289398771503565, dt = 0.01109564315326069 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.4%)
   patch tree reduce : 1092.00 ns (0.4%)
   gen split merge   : 673.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 979.00 ns  (0.3%)
   LB compute        : 277.75 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1832.00 ns (64.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.610040226140974e-18,-4.575148853519506e-17,2.3954471219111984e-17)
    sum a = (4.4987451264244524e-17,-9.577104734259656e-17,-4.824265986691501e-18)
    sum e = 2.592001195504309
    sum de = 5.285485590866834e-19
Info: CFL hydro = 0.011086322812413157 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011086322812413157 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9617e+04 |  512 |      1 | 2.610e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1530.4722399776576 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.300494414656827, dt = 0.011086322812413157 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1336.00 ns (0.5%)
   gen split merge   : 994.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 959.00 ns  (0.3%)
   LB compute        : 272.42 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.991747474756501e-18,-4.712148640034774e-17,2.3297282072259896e-17)
    sum a = (3.2220198189179817e-17,6.884532006978805e-17,9.390925537200445e-17)
    sum e = 2.5920011879756713
    sum de = 1.1587410718438829e-18
Info: CFL hydro = 0.011076956259963832 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011076956259963832 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6166e+04 |  512 |      1 | 3.167e-02 | 0.0% |   1.4% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1260.1770416952877 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.31158073746924, dt = 0.011076956259963832 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.86 us    (1.4%)
   patch tree reduce : 1862.00 ns (0.5%)
   gen split merge   : 842.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1030.00 ns (0.3%)
   LB compute        : 333.38 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.52 us    (70.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.2317898357447916e-18,-4.545729027569112e-17,2.495855085105081e-17)
    sum a = (-5.3578479543639476e-17,-1.5182386597922814e-16,1.8828688608252263e-17)
    sum e = 2.592001182240729
    sum de = 5.590417451878382e-19
Info: CFL hydro = 0.01107002360232864 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01107002360232864 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9390e+04 |  512 |      1 | 2.641e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.1665466814409 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.322657693729205, dt = 0.01107002360232864 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.4%)
   patch tree reduce : 1020.00 ns (0.3%)
   gen split merge   : 1047.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 1021.00 ns (0.4%)
   LB compute        : 274.63 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1988.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.160381248894616e-18,-4.82690059797064e-17,2.4677525647942565e-17)
    sum a = (-1.6311244347387566e-16,4.0988696811683486e-17,-6.75631425806067e-18)
    sum e = 2.5920011787410178
    sum de = 1.7618285302889447e-19
Info: CFL hydro = 0.011065569654606408 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011065569654606408 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9976e+04 |  512 |      1 | 2.563e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1554.8277907974968 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.333727717331534, dt = 0.011065569654606408 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.4%)
   patch tree reduce : 1658.00 ns (0.6%)
   gen split merge   : 870.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1024.00 ns (0.3%)
   LB compute        : 278.26 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1904.00 ns (64.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.8102520310824276e-19,-4.6717512670879643e-17,2.450334856893277e-17)
    sum a = (5.643703278150614e-17,-5.101192905587748e-17,-3.9121050149359957e-17)
    sum e = 2.592001177675133
    sum de = 2.320870275476783e-19
Info: CFL hydro = 0.011063605112694093 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011063605112694093 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9520e+04 |  512 |      1 | 2.623e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.7581897864695 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.34479328698614, dt = 0.011063605112694093 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1114.00 ns (0.4%)
   gen split merge   : 713.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1026.00 ns (0.3%)
   LB compute        : 278.46 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.54 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1837.00 ns (63.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5866214592152872e-18,-4.7857713885574025e-17,2.3918611232257026e-17)
    sum a = (-2.5197129539106245e-17,6.85057479493656e-17,4.4905485580004623e-17)
    sum e = 2.5920011790430615
    sum de = -3.2187251995663413e-19
Info: CFL hydro = 0.011064106754006287 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011064106754006287 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9770e+04 |  512 |      1 | 2.590e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.9349080329073 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.355856892098835, dt = 0.011064106754006287 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.4%)
   patch tree reduce : 1320.00 ns (0.5%)
   gen split merge   : 700.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 979.00 ns  (0.3%)
   LB compute        : 272.41 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.016225266389456e-19,-4.650820744148132e-17,2.4927813719460845e-17)
    sum a = (-3.8476302222437145e-17,1.6909520658692222e-16,-6.088879400678593e-17)
    sum e = 2.5920011826559044
    sum de = 1.2921487610364352e-18
Info: CFL hydro = 0.011067016485048783 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011067016485048783 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9388e+04 |  512 |      1 | 2.641e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1508.2939696210142 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.36692099885284, dt = 0.011067016485048783 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1306.00 ns (0.4%)
   gen split merge   : 690.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1042.00 ns (0.4%)
   LB compute        : 280.18 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.2739249639378587e-19,-4.4062409970679894e-17,2.3658809286675186e-17)
    sum a = (-4.662237393024404e-17,-1.800903176585322e-17,-3.9039084465120056e-17)
    sum e = 2.592001188158036
    sum de = 2.210755992333724e-18
Info: CFL hydro = 0.011069086467110896 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011069086467110896 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9911e+04 |  512 |      1 | 2.571e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1549.4082002394205 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.37798801533789, dt = 0.011069086467110896 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.6%)
   patch tree reduce : 1034.00 ns (0.3%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1159.00 ns (0.4%)
   LB compute        : 284.09 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1952.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.5222198501696481e-19,-4.5366542553854084e-17,2.3387297957630502e-17)
    sum a = (-7.799034855426878e-17,-1.4993865524171036e-17,-5.3301113522863373e-17)
    sum e = 2.5920011949832924
    sum de = 2.354751593366955e-19
Info: CFL hydro = 0.011072122037190777 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011072122037190777 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0027e+04 |  512 |      1 | 2.557e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1558.6925100740057 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.389057101805001, dt = 0.011072122037190777 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.4%)
   patch tree reduce : 1435.00 ns (0.5%)
   gen split merge   : 673.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 978.00 ns  (0.3%)
   LB compute        : 300.68 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.02 us    (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.2529040305242488e-18,-4.540313437717547e-17,2.278298399547782e-17)
    sum a = (1.5654274751475406e-16,-4.2911963045455526e-17,7.97174826150382e-17)
    sum e = 2.5920012025687074
    sum de = 1.0198276684941776e-18
Info: CFL hydro = 0.011077035472737976 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011077035472737976 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9536e+04 |  512 |      1 | 2.621e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1520.8774303595824 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.400129223842193, dt = 0.011077035472737976 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.79 us    (1.5%)
   patch tree reduce : 1398.00 ns (0.4%)
   gen split merge   : 665.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1254.00 ns (0.4%)
   LB compute        : 301.96 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.34 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.45 us    (70.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8090997450093127e-18,-4.6124725133073197e-17,2.4367604339355217e-17)
    sum a = (2.6307325458677088e-17,2.9207593375130124e-17,-3.793840241961277e-17)
    sum e = 2.5920012102985974
    sum de = -9.147955830346444e-19
Info: CFL hydro = 0.011083774472515066 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011083774472515066 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8477e+04 |  512 |      1 | 2.771e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1439.0536434118362 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.41120625931493, dt = 0.011083774472515066 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.4%)
   patch tree reduce : 1362.00 ns (0.4%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 979.00 ns  (0.3%)
   LB compute        : 291.84 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.422690090735479e-18,-4.551144617420677e-17,2.3323994103284507e-17)
    sum a = (-8.762204828892395e-17,3.349030037666512e-17,6.770365518216082e-17)
    sum e = 2.592001217527657
    sum de = -6.844026213814747e-19
Info: CFL hydro = 0.01109226586018905 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01109226586018905 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9422e+04 |  512 |      1 | 2.636e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1513.5753046026537 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.422290033787446, dt = 0.01109226586018905 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.49 us    (1.5%)
   patch tree reduce : 1484.00 ns (0.5%)
   gen split merge   : 702.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 279.93 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-3.5128150388530345e-20,-4.50079426853045e-17,2.4639836069921538e-17)
    sum a = (-3.522031604352108e-17,-6.429988377680551e-17,7.290262143966331e-17)
    sum e = 2.5920012236703545
    sum de = -1.6940658945086007e-19
Info: CFL hydro = 0.01110241728535667 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01110241728535667 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9470e+04 |  512 |      1 | 2.630e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.507973169097 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 10.433382299647635, dt = 0.01110241728535667 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1492.00 ns (0.5%)
   gen split merge   : 692.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1094.00 ns (0.4%)
   LB compute        : 278.51 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.32 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1923.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6978606021123e-19,-4.6370622185792906e-17,2.555719308058868e-17)
    sum a = (-1.1183943175860009e-16,-5.5337997368048315e-17,-4.917941054394248e-19)
    sum e = 2.59200122823943
    sum de = 1.5585406229479126e-19
Info: CFL hydro = 0.011114118425188266 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011114118425188266 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9762e+04 |  512 |      1 | 2.591e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.6623174019817 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.444484716932992, dt = 0.011114118425188266 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.5%)
   patch tree reduce : 1268.00 ns (0.4%)
   gen split merge   : 775.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1066.00 ns (0.4%)
   LB compute        : 278.75 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1997.00 ns (64.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.738843444232252e-18,-4.6784841625791e-17,2.5110772836067773e-17)
    sum a = (1.4709858087462098e-16,2.6744963665600864e-17,-9.580617549298509e-17)
    sum e = 2.592001230896088
    sum de = -5.353248226647178e-19
Info: CFL hydro = 0.011127241555687844 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011127241555687844 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9014e+04 |  512 |      1 | 2.693e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1485.8548069707156 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.455598835358181, dt = 0.011127241555687844 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.02 us    (1.6%)
   patch tree reduce : 1293.00 ns (0.4%)
   gen split merge   : 733.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 978.00 ns  (0.3%)
   LB compute        : 291.79 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.32 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5280745419010699e-18,-4.605593250522899e-17,2.3578307275368137e-17)
    sum a = (9.228604208946778e-17,-1.5573480005581785e-18,-1.3817072486155268e-17)
    sum e = 2.5920012314723686
    sum de = -1.0164395367051604e-19
Info: CFL hydro = 0.011141367875252925 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011141367875252925 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9413e+04 |  512 |      1 | 2.637e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.806759435738 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 10.466726076913869, dt = 0.011141367875252925 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 1670.00 ns (0.6%)
   gen split merge   : 922.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1051.00 ns (0.3%)
   LB compute        : 285.63 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.77 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0257233390719166e-18,-4.621840020077594e-17,2.3868114516073512e-17)
    sum a = (1.552956981759612e-17,5.154470600343686e-17,1.403018326517902e-16)
    sum e = 2.592001229946166
    sum de = -1.043544591017298e-18
Info: CFL hydro = 0.011144055789822478 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011144055789822478 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9418e+04 |  512 |      1 | 2.637e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1521.1685842808793 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.477867444789121, dt = 0.011144055789822478 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.5%)
   patch tree reduce : 1212.00 ns (0.4%)
   gen split merge   : 644.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 958.00 ns  (0.3%)
   LB compute        : 278.09 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.63 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9613217300262775e-18,-4.5410452741839744e-17,2.6305129949277804e-17)
    sum a = (-1.2565412577623945e-16,-1.3752378142523058e-16,-2.441406452002859e-17)
    sum e = 2.592001226219498
    sum de = 1.1655173354219173e-18
Info: CFL hydro = 0.011129880841286317 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011129880841286317 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9668e+04 |  512 |      1 | 2.603e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1541.0877994469683 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.489011500578943, dt = 0.01098849942105673 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.4%)
   patch tree reduce : 1406.00 ns (0.5%)
   gen split merge   : 641.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 294.01 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (70.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.283329775254472e-19,-4.788845101716399e-17,2.5031734497693582e-17)
    sum a = (-2.4627760768225483e-17,-3.931425497649688e-17,-5.542051192963804e-17)
    sum e = 2.592001217379413
    sum de = 3.3881317890172014e-20
Info: CFL hydro = 0.011116102901545064 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011116102901545064 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9892e+04 |  512 |      1 | 2.574e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.8944438093931 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 1297                                                    [SPH][rank=0]
Info: time since start : 1780.0963737670002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.1498789490377917 max=0.15013130071984002 delta=0.0002523516820483185
Number of particle pairs: 130816
Distance min=0.143911 max=1.987253 mean=0.803523
---------------- t = 10.5, dt = 0.011116102901545064 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.67 us    (1.4%)
   patch tree reduce : 1431.00 ns (0.2%)
   gen split merge   : 553.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 910.00 ns  (0.1%)
   LB compute        : 681.91 us  (96.3%)
   LB move op cnt    : 0
   LB apply          : 5.79 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.80 us    (81.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.6978606021123e-19,-4.7822585735185493e-17,2.4261842535011625e-17)
    sum a = (-1.1510214168505146e-16,3.330734126005819e-17,2.709551333301974e-17)
    sum e = 2.592001214171102
    sum de = -1.6737371037744975e-18
Info: CFL hydro = 0.011103869663197107 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011103869663197107 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4024e+04 |  512 |      1 | 3.651e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1096.133073840721 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 10.511116102901545, dt = 0.011103869663197107 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 1843.00 ns (0.6%)
   gen split merge   : 780.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1062.00 ns (0.3%)
   LB compute        : 299.21 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.70 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.7329887525008303e-18,-4.70834309040935e-17,2.498343329090935e-17)
    sum a = (-8.62714440901316e-17,-3.415334421524863e-17,1.280421081661931e-16)
    sum e = 2.59200120733751
    sum de = -5.421010862427522e-20
Info: CFL hydro = 0.011093609345402487 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011093609345402487 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9190e+04 |  512 |      1 | 2.668e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1498.2076230434125 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.522219972564741, dt = 0.011093609345402487 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.4%)
   patch tree reduce : 1269.00 ns (0.4%)
   gen split merge   : 812.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 282.94 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1831.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.587773745288402e-18,-4.7892842035962556e-17,2.6943291348002775e-17)
    sum a = (1.6414177146390623e-16,3.736756997579915e-18,8.204179523241262e-17)
    sum e = 2.592001200869185
    sum de = -2.710505431213761e-19
Info: CFL hydro = 0.011085464044748944 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011085464044748944 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9294e+04 |  512 |      1 | 2.654e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1504.9620813876838 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.533313581910145, dt = 0.011085464044748944 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.86 us    (1.6%)
   patch tree reduce : 1493.00 ns (0.5%)
   gen split merge   : 700.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 284.19 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1952.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.084176995020286e-19,-4.7472767904233046e-17,2.769415556255761e-17)
    sum a = (3.684650241170262e-17,1.062626549253043e-18,-1.2183613493088607e-17)
    sum e = 2.5920011953789435
    sum de = -6.098637220230962e-20
Info: CFL hydro = 0.011079537006951336 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011079537006951336 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9101e+04 |  512 |      1 | 2.681e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1488.8083115904467 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.544399045954894, dt = 0.011079537006951336 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.69 us    (1.4%)
   patch tree reduce : 1323.00 ns (0.4%)
   gen split merge   : 689.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 876.00 ns  (0.3%)
   LB compute        : 319.32 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.42 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.5713619561672516e-19,-4.75825433741972e-17,2.6960855423197037e-17)
    sum a = (-4.964156527249158e-17,6.623851857637253e-17,6.574709038916631e-17)
    sum e = 2.5920011914147802
    sum de = 4.54009659728305e-19
Info: CFL hydro = 0.01107591620146987 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01107591620146987 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9805e+04 |  512 |      1 | 2.585e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.9069183794054 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.555478582961845, dt = 0.01107591620146987 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.4%)
   patch tree reduce : 1215.00 ns (0.4%)
   gen split merge   : 683.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 887.00 ns  (0.3%)
   LB compute        : 290.36 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-6.557254739192331e-19,-4.6506743768548465e-17,2.813179376948138e-17)
    sum a = (3.0307360625054376e-17,-4.60325137383033e-18,7.231129757478971e-17)
    sum e = 2.5920011894099013
    sum de = -1.4162390878091902e-18
Info: CFL hydro = 0.011074651015887919 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011074651015887919 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9814e+04 |  512 |      1 | 2.584e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1543.0950496285009 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.566554499163315, dt = 0.011074651015887919 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.4%)
   patch tree reduce : 1257.00 ns (0.4%)
   gen split merge   : 716.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1234.00 ns (0.4%)
   LB compute        : 300.92 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1993.00 ns (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1123914289701276e-19,-4.6932672592009394e-17,2.905244404424745e-17)
    sum a = (-1.0455365668696854e-16,3.7695432712758767e-17,3.600049945651218e-17)
    sum e = 2.5920011896503667
    sum de = -1.4433441421213278e-18
Info: CFL hydro = 0.011075757593136639 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011075757593136639 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9534e+04 |  512 |      1 | 2.621e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1521.0849411430504 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.577629150179202, dt = 0.011075757593136639 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.5%)
   patch tree reduce : 1345.00 ns (0.5%)
   gen split merge   : 737.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 875.00 ns  (0.3%)
   LB compute        : 274.99 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.031578030803338e-18,-4.61935177609174e-17,2.923393948792152e-17)
    sum a = (1.092971233537885e-16,-8.021293590280976e-17,-2.9964312281416385e-17)
    sum e = 2.5920011922506485
    sum de = -8.538092108323347e-19
Info: CFL hydro = 0.0110792150331408 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0110792150331408 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9758e+04 |  512 |      1 | 2.591e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1538.6547672881873 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.588704907772339, dt = 0.0110792150331408 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.4%)
   patch tree reduce : 1256.00 ns (0.4%)
   gen split merge   : 700.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 885.00 ns  (0.3%)
   LB compute        : 286.04 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.156831129309424e-19,-4.764401763737713e-17,2.8480147927500975e-17)
    sum a = (2.5879201125816875e-17,1.0512889158452551e-16,-3.6966523592196767e-17)
    sum e = 2.5920011971485355
    sum de = -5.692061405548898e-19
Info: CFL hydro = 0.011083810548420059 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011083810548420059 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9527e+04 |  512 |      1 | 2.622e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1521.1388220776053 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.59978412280548, dt = 0.011083810548420059 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 1084.00 ns (0.4%)
   gen split merge   : 657.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 941.00 ns  (0.3%)
   LB compute        : 288.44 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1872.00 ns (64.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5760643618255584e-19,-4.5526082903535325e-17,2.8039582374711493e-17)
    sum a = (-6.351352549362892e-17,5.140382748364952e-17,1.0362804364616451e-16)
    sum e = 2.5920012040715124
    sum de = 7.521652571618187e-19
Info: CFL hydro = 0.011088614599222581 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011088614599222581 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9386e+04 |  512 |      1 | 2.641e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.8329622414876 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.6108679333539, dt = 0.011088614599222581 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.86 us    (1.6%)
   patch tree reduce : 1437.00 ns (0.5%)
   gen split merge   : 641.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 968.00 ns  (0.3%)
   LB compute        : 282.66 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1897.00 ns (63.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.835882108788495e-19,-4.519090180191143e-17,2.993503882275927e-17)
    sum a = (-5.734743734574221e-17,-1.1534254996427296e-16,-9.030276526544867e-17)
    sum e = 2.5920012125749072
    sum de = 1.7923217163900995e-18
Info: CFL hydro = 0.011095622518410335 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011095622518410335 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9511e+04 |  512 |      1 | 2.624e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1521.2279447340563 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.621956547953122, dt = 0.011095622518410335 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.3%)
   patch tree reduce : 1479.00 ns (0.4%)
   gen split merge   : 741.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 881.00 ns  (0.3%)
   LB compute        : 321.89 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.4988010832439613e-18,-4.7450812810240216e-17,2.788736038969453e-17)
    sum a = (1.330829977469472e-16,7.661595967031754e-17,-1.0030257874271698e-16)
    sum e = 2.592001222149767
    sum de = -8.165397611531455e-19
Info: CFL hydro = 0.011101438295002243 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011101438295002243 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9963e+04 |  512 |      1 | 2.565e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1557.4195800925675 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.633052170471533, dt = 0.011101438295002243 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.95 us    (1.3%)
   patch tree reduce : 1264.00 ns (0.4%)
   gen split merge   : 661.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 750.00 ns  (0.2%)
   LB compute        : 285.64 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.53 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0772632785815972e-18,-4.544411721929542e-17,2.668495307535379e-17)
    sum a = (8.49010803067457e-17,9.295933163858128e-17,-1.6650743284163382e-17)
    sum e = 2.5920012320703716
    sum de = 1.4501204056993622e-18
Info: CFL hydro = 0.011102121204988961 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011102121204988961 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9898e+04 |  512 |      1 | 2.573e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1553.1402989908295 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.644153608766535, dt = 0.011102121204988961 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.51 us    (1.2%)
   patch tree reduce : 991.00 ns  (0.3%)
   gen split merge   : 659.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 661.00 ns  (0.2%)
   LB compute        : 290.78 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 2.65 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.891065429249217e-18,-4.4418082493363766e-17,2.6978419498391303e-17)
    sum a = (-7.386864557534789e-17,1.3166616234794314e-16,1.0393248761619844e-16)
    sum e = 2.5920012415221487
    sum de = 1.618679962202968e-18
Info: CFL hydro = 0.011104223422539316 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011104223422539316 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0137e+04 |  512 |      1 | 2.543e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1571.905038497836 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 10.655255729971524, dt = 0.011104223422539316 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.55 us    (1.3%)
   patch tree reduce : 849.00 ns  (0.3%)
   gen split merge   : 965.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 580.00 ns  (0.2%)
   LB compute        : 266.68 us  (95.5%)
   LB move op cnt    : 0
   LB apply          : 2.04 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.854691731421724e-21,-4.2559217868637364e-17,2.873629069075068e-17)
    sum a = (-7.874267644175648e-17,-3.122307100367205e-17,4.194301156390523e-17)
    sum e = 2.5920012499406107
    sum de = 5.463362509790237e-19
Info: CFL hydro = 0.011107637090335078 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011107637090335078 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0121e+04 |  512 |      1 | 2.545e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1570.962471073081 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 10.666359953394062, dt = 0.011107637090335078 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.3%)
   patch tree reduce : 1062.00 ns (0.4%)
   gen split merge   : 674.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 771.00 ns  (0.3%)
   LB compute        : 286.85 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.36 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-7.376911581591372e-19,-4.3958489192447157e-17,2.886335579723419e-17)
    sum a = (4.019977710087441e-17,-1.050507337369e-16,-1.3531363529661888e-16)
    sum e = 2.5920012566844908
    sum de = -1.1350241493207625e-19
Info: CFL hydro = 0.011112239020098441 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011112239020098441 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0043e+04 |  512 |      1 | 2.554e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1565.3889759880851 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.677467590484397, dt = 0.011112239020098441 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.5%)
   patch tree reduce : 1088.00 ns (0.4%)
   gen split merge   : 666.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1339.00 ns (0.5%)
   LB compute        : 278.62 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.69 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1951.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.952975943416931e-20,-4.544118987342971e-17,2.6444544796132284e-17)
    sum a = (1.1605316317317426e-16,9.03378934158372e-17,-2.3114322955652967e-17)
    sum e = 2.592001261224132
    sum de = 1.1418004128987969e-18
Info: CFL hydro = 0.01111789215304128 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01111789215304128 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9776e+04 |  512 |      1 | 2.589e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1545.1190962107632 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.688579829504496, dt = 0.01111789215304128 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.82 us    (1.3%)
   patch tree reduce : 1295.00 ns (0.4%)
   gen split merge   : 827.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 693.00 ns  (0.2%)
   LB compute        : 279.13 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.54 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8208091284721562e-18,-4.332764615838647e-17,2.6866448519027864e-17)
    sum a = (-3.210566578218388e-17,1.1733680433528848e-16,1.1287845658181083e-17)
    sum e = 2.5920012631998657
    sum de = 5.421010862427522e-20
Info: CFL hydro = 0.011122068731276897 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011122068731276897 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0150e+04 |  512 |      1 | 2.541e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1575.1890500987772 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.699697721657538, dt = 0.011122068731276897 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.53 us    (1.2%)
   patch tree reduce : 852.00 ns  (0.3%)
   gen split merge   : 1008.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 628.00 ns  (0.2%)
   LB compute        : 292.75 us  (95.6%)
   LB move op cnt    : 0
   LB apply          : 2.69 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.020927672047761e-19,-4.1685405127722676e-17,2.7088926804821888e-17)
    sum a = (7.138918362709079e-17,2.3489023226463956e-17,6.189580098459047e-17)
    sum e = 2.592001262361981
    sum de = -1.9583401740519424e-18
Info: CFL hydro = 0.011117696292804569 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011117696292804569 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9874e+04 |  512 |      1 | 2.576e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1554.1694502273597 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.710819790388815, dt = 0.011117696292804569 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.48 us    (1.2%)
   patch tree reduce : 737.00 ns  (0.3%)
   gen split merge   : 1028.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 721.00 ns  (0.3%)
   LB compute        : 268.06 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 2.46 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1828.00 ns (63.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0374327225347597e-18,-4.206303274439938e-17,2.808934725442858e-17)
    sum a = (7.331537720672854e-17,-4.491426761760175e-17,-4.894522287468561e-17)
    sum e = 2.592001258534319
    sum de = -1.1316360175317453e-18
Info: CFL hydro = 0.011114544643580056 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011114544643580056 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9869e+04 |  512 |      1 | 2.577e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1553.1953979107243 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.72193748668162, dt = 0.011114544643580056 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.1%)
   patch tree reduce : 896.00 ns  (0.2%)
   gen split merge   : 678.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 854.00 ns  (0.2%)
   LB compute        : 390.26 us  (96.4%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1973.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.0151662416821877e-18,-4.2982219346232584e-17,2.6839370569770037e-17)
    sum a = (2.917246522474159e-17,-3.4823706418496415e-17,-2.9601321394068236e-17)
    sum e = 2.592001252221133
    sum de = -8.876905287225068e-19
Info: CFL hydro = 0.011112271866629529 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011112271866629529 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9947e+04 |  512 |      1 | 2.567e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1558.8673697540378 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.7330520313252, dt = 0.011112271866629529 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.5%)
   patch tree reduce : 1613.00 ns (0.6%)
   gen split merge   : 658.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 817.00 ns  (0.3%)
   LB compute        : 272.00 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.56 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.0854225424592483e-18,-4.331447310199077e-17,2.670471265994734e-17)
    sum a = (2.312895968498152e-17,-1.0577086081986486e-16,8.013902041970056e-17)
    sum e = 2.5920012438620232
    sum de = 3.1170812458958252e-19
Info: CFL hydro = 0.01110845535496754 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01110845535496754 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9927e+04 |  512 |      1 | 2.569e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1556.961407459203 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 10.744164303191829, dt = 0.01110845535496754 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.4%)
   patch tree reduce : 1184.00 ns (0.4%)
   gen split merge   : 601.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 785.00 ns  (0.3%)
   LB compute        : 282.81 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1935.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.2493539109390567e-18,-4.4901094561206056e-17,2.8234250874781266e-17)
    sum a = (-8.708634399549886e-17,-8.691875344468691e-17,3.3278067801401077e-17)
    sum e = 2.5920012340021983
    sum de = -1.2197274440461925e-19
Info: CFL hydro = 0.01110554723349701 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01110554723349701 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0215e+04 |  512 |      1 | 2.533e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1578.9317961817333 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.755272758546797, dt = 0.01110554723349701 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.83 us    (1.3%)
   patch tree reduce : 802.00 ns  (0.3%)
   gen split merge   : 827.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 716.00 ns  (0.3%)
   LB compute        : 270.67 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.61 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1973.00 ns (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5866214592152872e-18,-4.575441588106077e-17,2.838940020566394e-17)
    sum a = (-5.843714184425308e-17,2.8395254897395363e-18,-5.723546636637877e-17)
    sum e = 2.592001223411452
    sum de = 4.0657581468206416e-20
Info: CFL hydro = 0.011103647720482487 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011103647720482487 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9694e+04 |  512 |      1 | 2.600e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.7943059176446 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.766378305780293, dt = 0.011103647720482487 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.94 us    (1.3%)
   patch tree reduce : 786.00 ns  (0.3%)
   gen split merge   : 672.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1230.00 ns (0.4%)
   LB compute        : 287.06 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.52 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.18850242147861e-18,-4.515138263272433e-17,2.7180406363125353e-17)
    sum a = (2.267529425944298e-16,6.634536670047098e-17,3.3301486568326764e-17)
    sum e = 2.592001212885711
    sum de = -1.0706496453294356e-18
Info: CFL hydro = 0.011102840908711257 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011102840908711257 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9675e+04 |  512 |      1 | 2.602e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.0805306474188 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.777481953500775, dt = 0.011102840908711257 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.4%)
   patch tree reduce : 1183.00 ns (0.4%)
   gen split merge   : 662.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1612.00 ns (0.5%)
   LB compute        : 304.85 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.216530332696756e-18,-4.400679039923139e-17,2.8041046047644345e-17)
    sum a = (-2.080976992287209e-18,-3.9984617179744664e-17,-8.107577109672804e-17)
    sum e = 2.5920012032115096
    sum de = -8.131516293641283e-20
Info: CFL hydro = 0.011102668436219607 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011102668436219607 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9386e+04 |  512 |      1 | 2.641e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1513.3739839868192 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.788584794409486, dt = 0.011102668436219607 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.4%)
   patch tree reduce : 1635.00 ns (0.5%)
   gen split merge   : 606.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 950.00 ns  (0.3%)
   LB compute        : 291.38 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.928498151783977e-18,-4.5119181828201517e-17,2.6477843355354747e-17)
    sum a = (4.694390170779114e-17,-8.266824724767474e-17,4.334813757944644e-17)
    sum e = 2.5920011951196393
    sum de = 7.453889935837843e-19
Info: CFL hydro = 0.011103661282095115 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011103661282095115 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9347e+04 |  512 |      1 | 2.646e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.3022890313484 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.799687462845705, dt = 0.011103661282095115 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.4%)
   patch tree reduce : 1595.00 ns (0.5%)
   gen split merge   : 681.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1039.00 ns (0.3%)
   LB compute        : 320.15 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.75400968591444e-18,-4.629597486621728e-17,2.7660491085101934e-17)
    sum a = (-7.493968824396486e-17,-1.1322973808569613e-17,5.784435430644663e-18)
    sum e = 2.592001189262423
    sum de = -4.0657581468206416e-19
Info: CFL hydro = 0.011104538947286385 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011104538947286385 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8857e+04 |  512 |      1 | 2.715e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1472.2371541339267 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.8107911241278, dt = 0.011104538947286385 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.3%)
   patch tree reduce : 1395.00 ns (0.4%)
   gen split merge   : 690.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1051.00 ns (0.3%)
   LB compute        : 319.21 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.2903367530590087e-18,-4.6029586392437594e-17,2.7560961325667764e-17)
    sum a = (2.0490908774449534e-16,-1.3151101301706047e-17,-7.922568850959876e-17)
    sum e = 2.5920011861110477
    sum de = 4.54009659728305e-19
Info: CFL hydro = 0.011105334284412622 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011105334284412622 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9196e+04 |  512 |      1 | 2.667e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1498.7811338230395 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.821895663075086, dt = 0.011105334284412622 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.5%)
   patch tree reduce : 1236.00 ns (0.4%)
   gen split merge   : 651.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1363.00 ns (0.5%)
   LB compute        : 280.42 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1867.00 ns (64.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.171997370991612e-18,-4.6170098993991714e-17,2.6129489197335155e-17)
    sum a = (-2.5863100723555463e-18,-3.047147495265079e-17,-3.78915648857614e-17)
    sum e = 2.5920011859664616
    sum de = -2.574980159653073e-19
Info: CFL hydro = 0.011100170220051522 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011100170220051522 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9249e+04 |  512 |      1 | 2.660e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1503.0164473383911 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.833000997359498, dt = 0.011100170220051522 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 8.07 us    (2.5%)
   patch tree reduce : 1219.00 ns (0.4%)
   gen split merge   : 625.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1001.00 ns (0.3%)
   LB compute        : 304.67 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.48 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.024477791632954e-18,-4.6644329024236877e-17,2.6035814129632407e-17)
    sum a = (-3.574142934739677e-17,1.048252823654611e-17,-3.768665067516164e-17)
    sum e = 2.592001188831215
    sum de = -8.74138001566438e-19
Info: CFL hydro = 0.011095592490173244 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011095592490173244 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9437e+04 |  512 |      1 | 2.634e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1517.0139576501251 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.84410116757955, dt = 0.011095592490173244 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1207.00 ns (0.4%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 889.00 ns  (0.3%)
   LB compute        : 288.38 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.427299235027938e-18,-4.6369158512860054e-17,2.5497182490341606e-17)
    sum a = (-1.9926443307893836e-17,-4.7832831445715485e-17,5.50341022753642e-17)
    sum e = 2.592001194651442
    sum de = -6.911788849595091e-19
Info: CFL hydro = 0.011092502877318621 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011092502877318621 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9878e+04 |  512 |      1 | 2.576e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1550.8147735124046 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.855196760069724, dt = 0.011092502877318621 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1264.00 ns (0.4%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1406.00 ns (0.5%)
   LB compute        : 272.59 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.38 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.321914783862347e-18,-4.709806763342206e-17,2.6606646573446024e-17)
    sum a = (-9.717617335813778e-17,-6.502952473383395e-17,-4.2479447693796744e-17)
    sum e = 2.5920012030804473
    sum de = 8.470329472543003e-19
Info: CFL hydro = 0.011090931936622144 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011090931936622144 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0018e+04 |  512 |      1 | 2.558e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1561.2566961093796 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.866289262947042, dt = 0.011090931936622144 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.5%)
   patch tree reduce : 1414.00 ns (0.5%)
   gen split merge   : 728.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 773.00 ns  (0.3%)
   LB compute        : 265.76 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1903.00 ns (63.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.846532467544073e-18,-4.7935288551015365e-17,2.5705024046807078e-17)
    sum a = (2.051191248103601e-17,-2.0950428891719497e-16,2.6922799926942796e-17)
    sum e = 2.5920012135827846
    sum de = 3.3881317890172014e-19
Info: CFL hydro = 0.011090892344040149 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011090892344040149 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0571e+04 |  512 |      1 | 2.489e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1604.2094452788003 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.877380194883663, dt = 0.011090892344040149 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.5%)
   patch tree reduce : 1375.00 ns (0.5%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1501.00 ns (0.5%)
   LB compute        : 278.83 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.64 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.78913783630297e-18,-5.1032420476937454e-17,2.6357822174860602e-17)
    sum a = (-1.420816589381424e-16,-6.412351118839643e-17,3.338345225256667e-17)
    sum e = 2.592001225477724
    sum de = -6.369687763352339e-19
Info: CFL hydro = 0.01109237968070852 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01109237968070852 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0647e+04 |  512 |      1 | 2.480e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1610.104777777911 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 10.888471087227703, dt = 0.01109237968070852 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.4%)
   patch tree reduce : 1315.00 ns (0.4%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 936.00 ns  (0.3%)
   LB compute        : 295.39 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.55 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.201364091014568e-18,-5.0985582943086085e-17,2.6747159175000144e-17)
    sum a = (-9.224652292028068e-17,-1.0379782970637574e-16,-2.081928379693565e-17)
    sum e = 2.592001237982237
    sum de = 1.1180834903756764e-19
Info: CFL hydro = 0.011095368776127722 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011095368776127722 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9909e+04 |  512 |      1 | 2.572e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1552.7543383843017 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.899563466908411, dt = 0.011095368776127722 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.65 us    (1.6%)
   patch tree reduce : 1424.00 ns (0.5%)
   gen split merge   : 716.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1127.00 ns (0.4%)
   LB compute        : 274.63 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1950.00 ns (64.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.481237008049696e-18,-5.230142490972311e-17,2.6179254077052237e-17)
    sum a = (3.0795678507278268e-18,5.304936177841224e-17,-6.626340101623107e-17)
    sum e = 2.592001250263844
    sum de = -1.2468324983583301e-18
Info: CFL hydro = 0.011099815987865505 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011099815987865505 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9574e+04 |  512 |      1 | 2.616e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.0540193006682 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.910658835684538, dt = 0.011099815987865505 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.6%)
   patch tree reduce : 1537.00 ns (0.5%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 875.00 ns  (0.3%)
   LB compute        : 276.89 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1947.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0901249481175553e-18,-5.088166216485335e-17,2.523372136242763e-17)
    sum a = (4.7627917235115727e-17,8.129824938252205e-17,1.8149544367407345e-17)
    sum e = 2.5920012615059935
    sum de = 7.301424005332069e-19
Info: CFL hydro = 0.011105659455592583 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011105659455592583 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9486e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1520.814053815172 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 10.921758651672404, dt = 0.011105659455592583 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.5%)
   patch tree reduce : 1439.00 ns (0.5%)
   gen split merge   : 979.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1083.00 ns (0.3%)
   LB compute        : 293.98 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.65 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2000.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.775123880693897e-18,-4.983513601786171e-17,2.5775280347584138e-17)
    sum a = (-7.520936998184346e-17,-4.958338427341058e-17,7.179023001069318e-17)
    sum e = 2.5920012709551448
    sum de = -3.2695471764015993e-19
Info: CFL hydro = 0.011112820179765929 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011112820179765929 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9900e+04 |  512 |      1 | 2.573e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1553.9552081123516 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.932864311127997, dt = 0.011112820179765929 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.3%)
   patch tree reduce : 1401.00 ns (0.5%)
   gen split merge   : 905.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 866.00 ns  (0.3%)
   LB compute        : 290.20 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.36 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.375852556884105e-18,-5.10441298604003e-17,2.7010620302914122e-17)
    sum a = (1.2956432801636275e-17,1.5774881401142692e-16,-3.0467815770318654e-17)
    sum e = 2.5920012779742634
    sum de = 1.4602848010664138e-18
Info: CFL hydro = 0.01111469287529606 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01111469287529606 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9841e+04 |  512 |      1 | 2.581e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1550.3229173658617 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.943977131307763, dt = 0.01111469287529606 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1596.00 ns (0.5%)
   gen split merge   : 783.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 885.00 ns  (0.3%)
   LB compute        : 280.84 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0432874142661817e-18,-4.800700852472528e-17,2.6027032092035272e-17)
    sum a = (-4.6404286663248586e-17,-2.7323846310545186e-17,1.4051260155412136e-18)
    sum e = 2.592001281923047
    sum de = -1.548376227580861e-18
Info: CFL hydro = 0.011112252350702444 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011112252350702444 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9977e+04 |  512 |      1 | 2.563e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1561.2210882287845 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.955091824183059, dt = 0.011112252350702444 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.91 us    (1.7%)
   patch tree reduce : 1636.00 ns (0.6%)
   gen split merge   : 1001.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1027.00 ns (0.3%)
   LB compute        : 276.25 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3290150230327312e-18,-4.9467754111715e-17,2.622023691917219e-17)
    sum a = (-1.2166049417894343e-17,2.6498334776414722e-17,-9.299592346190266e-17)
    sum e = 2.592001282568159
    sum de = 8.944667923005412e-19
Info: CFL hydro = 0.01111127335018415 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01111127335018415 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0109e+04 |  512 |      1 | 2.546e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1571.1871846446993 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.966204076533762, dt = 0.01111127335018415 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.57 us    (1.1%)
   patch tree reduce : 1074.00 ns (0.3%)
   gen split merge   : 746.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 845.00 ns  (0.3%)
   LB compute        : 313.78 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 3.34 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4695276245868527e-18,-4.903597059652265e-17,2.4700944414868253e-17)
    sum a = (6.953031900236439e-17,8.171978718718442e-17,1.2041929953188202e-16)
    sum e = 2.5920012800375285
    sum de = -1.4501204056993622e-18
Info: CFL hydro = 0.011111783038938693 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011111783038938693 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9809e+04 |  512 |      1 | 2.585e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1547.6193014505561 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.977315349883947, dt = 0.011111783038938693 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.4%)
   patch tree reduce : 1376.00 ns (0.5%)
   gen split merge   : 756.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 950.00 ns  (0.3%)
   LB compute        : 279.82 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1934.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.710722271648258e-18,-4.7676218441899954e-17,2.7214070840581027e-17)
    sum a = (8.175491533757296e-17,8.285559738308023e-17,-2.112372776696958e-17)
    sum e = 2.592001274552652
    sum de = -2.2497195079074217e-18
Info: CFL hydro = 0.011113792534340554 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011113792534340554 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9554e+04 |  512 |      1 | 2.618e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.7409888660115 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 10.988427132922885, dt = 0.011113792534340554 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1305.00 ns (0.4%)
   gen split merge   : 737.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1299.00 ns (0.4%)
   LB compute        : 286.63 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.553797880972986e-18,-4.678191427992529e-17,2.6193890806380793e-17)
    sum a = (-9.878035889254732e-17,9.216455723604078e-17,1.567183882666967e-16)
    sum e = 2.59200126651689
    sum de = -1.8431436932253575e-18
Info: CFL hydro = 0.011117296254657676 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011117296254657676 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9789e+04 |  512 |      1 | 2.587e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1546.413091512039 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 10.999540925457225, dt = 0.00045907454277482884 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.5%)
   patch tree reduce : 1461.00 ns (0.5%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 887.00 ns  (0.3%)
   LB compute        : 285.02 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1867.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5350815197056066e-18,-4.682436079497809e-17,2.724627164510385e-17)
    sum a = (-7.180193939415602e-17,1.0760923402353128e-17,5.1849149973470786e-17)
    sum e = 2.5920011321390373
    sum de = 1.260385025514399e-18
Info: CFL hydro = 0.011118194978734924 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011118194978734924 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9859e+04 |  512 |      1 | 2.578e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 64.10281354134676 (tsim/hr)                             [sph::Model][rank=0]
Info: iteration since start : 1343                                                    [SPH][rank=0]
Info: time since start : 1782.0566655060002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.1498661283829156 max=0.15015293561719628 delta=0.0002868072342806782
Number of particle pairs: 130816
Distance min=0.143324 max=1.986289 mean=0.802986
---------------- t = 11, dt = 0.011118194978734924 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.84 us    (1.9%)
   patch tree reduce : 1609.00 ns (0.3%)
   gen split merge   : 438.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 809.00 ns  (0.2%)
   LB compute        : 498.83 us  (95.5%)
   LB move op cnt    : 0
   LB apply          : 4.56 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.59 us    (78.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.756407519426517e-18,-4.6695557576886813e-17,2.7837595509977444e-17)
    sum a = (7.784398126098325e-17,3.444900614768542e-17,-7.025630077706068e-18)
    sum e = 2.592001259499712
    sum de = 9.147955830346444e-19
Info: CFL hydro = 0.011122045576791008 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011122045576791008 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6843e+04 |  512 |      1 | 3.040e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1316.6960932939353 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.011118194978735, dt = 0.011122045576791008 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.4%)
   patch tree reduce : 1886.00 ns (0.6%)
   gen split merge   : 689.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 734.00 ns  (0.2%)
   LB compute        : 280.19 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.3605930538360694e-18,-4.6175953685723133e-17,2.7404348321852235e-17)
    sum a = (-8.249260649573209e-17,-8.61342247526764e-17,-4.2153780466236414e-17)
    sum e = 2.592001246699225
    sum de = -4.0657581468206416e-19
Info: CFL hydro = 0.011127862894806093 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011127862894806093 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5591e+04 |  512 |      1 | 3.284e-02 | 0.0% |   1.4% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1219.272796871609 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 11.022240240555526, dt = 0.011127862894806093 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.3%)
   patch tree reduce : 1208.00 ns (0.4%)
   gen split merge   : 630.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 825.00 ns  (0.3%)
   LB compute        : 301.94 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5866214592152872e-18,-4.756424746253651e-17,2.6827661186307194e-17)
    sum a = (1.0611043294028733e-16,5.079530546181488e-17,2.4659961572748302e-17)
    sum e = 2.592001235139868
    sum de = -1.2536087619363645e-18
Info: CFL hydro = 0.011132947797879801 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011132947797879801 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9417e+04 |  512 |      1 | 2.637e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1519.2336090624638 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.033368103450332, dt = 0.011132947797879801 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.56 us    (1.5%)
   patch tree reduce : 1404.00 ns (0.5%)
   gen split merge   : 661.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 974.00 ns  (0.3%)
   LB compute        : 277.77 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.022173219486724e-18,-4.635964463879649e-17,2.7520710320014242e-17)
    sum a = (1.6224521726115882e-16,-2.5141217233071166e-16,6.503391575263251e-17)
    sum e = 2.592001224112831
    sum de = -8.131516293641283e-20
Info: CFL hydro = 0.011134625093045712 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011134625093045712 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8011e+04 |  512 |      1 | 2.843e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1409.8826725352585 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.044501051248211, dt = 0.011134625093045712 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 1592.00 ns (0.5%)
   gen split merge   : 668.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 872.00 ns  (0.3%)
   LB compute        : 281.89 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.0947340924100145e-18,-5.111365432471093e-17,2.8466608952872065e-17)
    sum a = (-1.8969201209806386e-17,4.800847219765814e-19,-2.7634144972310537e-17)
    sum e = 2.5920012143846782
    sum de = 1.4907779871675686e-19
Info: CFL hydro = 0.011137984838415941 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137984838415941 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9560e+04 |  512 |      1 | 2.618e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.3243985737172 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.055635676341257, dt = 0.011137984838415941 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 1415.00 ns (0.5%)
   gen split merge   : 644.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 808.00 ns  (0.3%)
   LB compute        : 296.15 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.912086362662826e-18,-4.96024120215377e-17,2.761072620538485e-17)
    sum a = (-4.981757194266745e-17,1.3170129049833168e-16,3.758712091572747e-17)
    sum e = 2.5920012067877725
    sum de = 9.0801931945661e-19
Info: CFL hydro = 0.011142613417492217 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011142613417492217 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9654e+04 |  512 |      1 | 2.605e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1539.206696741242 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 11.066773661179674, dt = 0.011142613417492217 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.5%)
   patch tree reduce : 1509.00 ns (0.5%)
   gen split merge   : 665.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 910.00 ns  (0.3%)
   LB compute        : 277.23 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.1451217458465805e-18,-4.746032668430378e-17,2.843733549421495e-17)
    sum a = (4.001096329253606e-17,6.478801869991279e-17,1.908629504443482e-18)
    sum e = 2.592001201907412
    sum de = 5.55653613398821e-19
Info: CFL hydro = 0.011140326347964753 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011140326347964753 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9411e+04 |  512 |      1 | 2.638e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1520.744871285703 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 11.077916274597166, dt = 0.011140326347964753 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.71 us    (1.6%)
   patch tree reduce : 1358.00 ns (0.5%)
   gen split merge   : 881.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 282.57 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.269222558279552e-18,-4.6992683182256465e-17,2.832664522866776e-17)
    sum a = (6.631023855008245e-17,-1.071818415271375e-16,-4.4964032497318837e-17)
    sum e = 2.592001200039337
    sum de = 7.182839392716467e-19
Info: CFL hydro = 0.011135716322648873 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011135716322648873 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8214e+04 |  512 |      1 | 2.811e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1426.7408110687536 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.089056600945131, dt = 0.011135716322648873 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.93 us    (1.6%)
   patch tree reduce : 1439.00 ns (0.5%)
   gen split merge   : 1066.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 917.00 ns  (0.3%)
   LB compute        : 284.49 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.0478965585586405e-18,-4.9305286416168045e-17,2.749216869782356e-17)
    sum a = (1.3810046856077562e-16,1.9613217300262775e-18,-1.879004764282488e-16)
    sum e = 2.5920012014294116
    sum de = -2.303929616531697e-19
Info: CFL hydro = 0.011132663664788153 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011132663664788153 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8529e+04 |  512 |      1 | 2.763e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1450.7710407270347 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.10019231726778, dt = 0.011132663664788153 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1928.00 ns (0.7%)
   gen split merge   : 871.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 279.04 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.32 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.839432228373688e-18,-4.8529905679987884e-17,2.470350584250075e-17)
    sum a = (-9.630967898188736e-18,2.1984367451488575e-17,-1.5283087295703268e-16)
    sum e = 2.592001206070829
    sum de = -6.369687763352339e-19
Info: CFL hydro = 0.011131184152213579 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011131184152213579 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9171e+04 |  512 |      1 | 2.671e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1500.6562281124698 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.111324980932569, dt = 0.011131184152213579 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.3%)
   patch tree reduce : 1245.00 ns (0.4%)
   gen split merge   : 728.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 889.00 ns  (0.3%)
   LB compute        : 314.38 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (70.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.896826859614791e-18,-4.796822119200461e-17,2.31600627348047e-17)
    sum a = (-5.554931514772931e-17,4.9100372205568286e-17,1.6990315404585843e-17)
    sum e = 2.5920012136785795
    sum de = 6.708500942254059e-19
Info: CFL hydro = 0.011131274014020396 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011131274014020396 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9055e+04 |  512 |      1 | 2.687e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1491.3280819108913 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.122456165084783, dt = 0.011131274014020396 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1485.00 ns (0.5%)
   gen split merge   : 686.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 940.00 ns  (0.3%)
   LB compute        : 288.59 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1988.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.1298622427985446e-18,-4.752472829334942e-17,2.4291115993668732e-17)
    sum a = (-9.68892934632981e-17,-1.070998758428976e-16,4.408582873760558e-18)
    sum e = 2.5920012237743992
    sum de = 8.063753657860939e-19
Info: CFL hydro = 0.011131379252069704 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011131379252069704 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8376e+04 |  512 |      1 | 2.786e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1438.2626553371792 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.133587439098804, dt = 0.011131379252069704 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.17 us    (1.8%)
   patch tree reduce : 1222.00 ns (0.4%)
   gen split merge   : 668.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1211.00 ns (0.4%)
   LB compute        : 278.03 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.0760177311426344e-18,-4.9474706558146064e-17,2.42215915293581e-17)
    sum a = (-1.3612158275555508e-17,4.506941694848443e-17,8.780281189613159e-17)
    sum e = 2.5920012356821087
    sum de = 3.049318610115481e-19
Info: CFL hydro = 0.011125135878723828 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011125135878723828 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9199e+04 |  512 |      1 | 2.667e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1502.6340199160556 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.144718818350874, dt = 0.011125135878723828 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1464.00 ns (0.5%)
   gen split merge   : 628.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 863.00 ns  (0.3%)
   LB compute        : 278.50 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.41 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1900.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.485846152342155e-18,-4.807982625313484e-17,2.5676482424616397e-17)
    sum a = (-3.230618897398507e-17,-1.4164145930358613e-16,2.041238272160184e-17)
    sum e = 2.592001248494485
    sum de = 4.811147140404426e-19
Info: CFL hydro = 0.011120481048473404 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011120481048473404 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8846e+04 |  512 |      1 | 2.717e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1474.192456563046 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 11.155843954229598, dt = 0.011120481048473404 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.5%)
   patch tree reduce : 1712.00 ns (0.6%)
   gen split merge   : 692.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 921.00 ns  (0.3%)
   LB compute        : 291.97 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.50 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.7423003024515966e-18,-5.0708948758776405e-17,2.5489132289210904e-17)
    sum a = (-4.469471667767344e-17,-1.0195067446511218e-16,1.958248016867281e-17)
    sum e = 2.5920012614789822
    sum de = -7.691059161069047e-19
Info: CFL hydro = 0.011117418036000366 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011117418036000366 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9115e+04 |  512 |      1 | 2.678e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1494.6352998420475 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.166964435278071, dt = 0.011117418036000366 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.84 us    (1.2%)
   patch tree reduce : 1697.00 ns (0.5%)
   gen split merge   : 698.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 832.00 ns  (0.3%)
   LB compute        : 310.88 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.1802498962351106e-18,-5.1710832881315946e-17,2.5796503605110542e-17)
    sum a = (1.4610968684936055e-16,1.5106421972707618e-16,-9.975223771996333e-17)
    sum e = 2.592001273787568
    sum de = 2.1175823681357508e-19
Info: CFL hydro = 0.01111593496148989 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01111593496148989 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9184e+04 |  512 |      1 | 2.669e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1499.5749591654335 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.178081853314072, dt = 0.01111593496148989 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1487.00 ns (0.5%)
   gen split merge   : 1007.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 789.00 ns  (0.3%)
   LB compute        : 281.96 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1971.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.154433295797347e-18,-4.8261687615042124e-17,2.3959228156143762e-17)
    sum a = (-8.33591008719825e-17,1.0306892058581374e-16,5.693102239634484e-17)
    sum e = 2.592001284633968
    sum de = 3.4558944247975454e-19
Info: CFL hydro = 0.011116002924949407 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011116002924949407 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9789e+04 |  512 |      1 | 2.587e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1546.6810670283248 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.189197788275562, dt = 0.011116002924949407 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.3%)
   patch tree reduce : 1297.00 ns (0.4%)
   gen split merge   : 755.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1097.00 ns (0.3%)
   LB compute        : 303.83 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.99405204690273e-18,-4.763230825391429e-17,2.5511819219670163e-17)
    sum a = (1.6111233441112871e-16,-1.826956554790149e-17,-1.0016792083289427e-16)
    sum e = 2.592001293319409
    sum de = -4.599388903590851e-19
Info: CFL hydro = 0.011117577121462602 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011117577121462602 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0091e+04 |  512 |      1 | 2.548e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1570.30544342344 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 11.20031379120051, dt = 0.011117577121462602 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.4%)
   patch tree reduce : 1089.00 ns (0.4%)
   gen split merge   : 650.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 806.00 ns  (0.3%)
   LB compute        : 277.41 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1795.00 ns (64.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.056055822436292e-18,-4.859577096196638e-17,2.3586357476498842e-17)
    sum a = (-1.0070655247218508e-16,4.421463195569686e-17,1.4637900266900594e-16)
    sum e = 2.5920012993015895
    sum de = -3.6422416731934915e-19
Info: CFL hydro = 0.011120457784642093 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011120457784642093 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9351e+04 |  512 |      1 | 2.646e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1512.6982026922676 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.211431368321973, dt = 0.011120457784642093 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.4%)
   patch tree reduce : 1171.00 ns (0.4%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 800.00 ns  (0.3%)
   LB compute        : 291.47 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1989.00 ns (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.456572693685047e-18,-4.7721958221051686e-17,2.662530840333993e-17)
    sum a = (-1.0343044780022903e-16,1.6222179849423312e-16,-6.921416564886762e-17)
    sum e = 2.592001302201694
    sum de = -8.131516293641283e-20
Info: CFL hydro = 0.011116402150026137 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011116402150026137 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9663e+04 |  512 |      1 | 2.604e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.4508769953418 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.222551826106615, dt = 0.011116402150026137 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 2.26 us    (0.8%)
   gen split merge   : 963.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 901.00 ns  (0.3%)
   LB compute        : 274.73 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.358817994043474e-18,-4.503062961576376e-17,2.449914050925081e-17)
    sum a = (-1.2519233696592358e-16,-4.8178258257869365e-17,-3.782130858498434e-18)
    sum e = 2.592001301636335
    sum de = 5.793705359219414e-19
Info: CFL hydro = 0.011113147293106012 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011113147293106012 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0023e+04 |  512 |      1 | 2.557e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1565.0633161819155 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.233668228256642, dt = 0.011113147293106012 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1537.00 ns (0.5%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 797.00 ns  (0.3%)
   LB compute        : 281.83 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.34 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.7956153017538732e-18,-4.6957555031867934e-17,2.476740431397572e-17)
    sum a = (5.284737491367819e-17,-6.324823477454888e-17,-4.3921897369125773e-17)
    sum e = 2.5920012979115943
    sum de = 4.743384504624082e-20
Info: CFL hydro = 0.011109077696026665 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011109077696026665 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9798e+04 |  512 |      1 | 2.586e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1547.0365392258766 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.244781375549747, dt = 0.011109077696026665 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.5%)
   patch tree reduce : 1359.00 ns (0.5%)
   gen split merge   : 715.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 837.00 ns  (0.3%)
   LB compute        : 278.21 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.461275099343353e-18,-4.7753793107341294e-17,2.4093154229500035e-17)
    sum a = (-2.1689437355518203e-17,3.127576322925485e-17,-3.8395068374663666e-17)
    sum e = 2.5920012912745407
    sum de = -8.673617379884035e-19
Info: CFL hydro = 0.011106077413109101 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011106077413109101 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9265e+04 |  512 |      1 | 2.658e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1504.7805735834675 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.255890453245774, dt = 0.011106077413109101 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.74 us    (1.6%)
   patch tree reduce : 1151.00 ns (0.4%)
   gen split merge   : 676.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1218.00 ns (0.4%)
   LB compute        : 273.52 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1974.00 ns (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.6650370238699994e-18,-4.6774595915261005e-17,2.3794564951197528e-17)
    sum a = (1.71793121720408e-17,1.738843444232252e-18,-5.965930874318737e-17)
    sum e = 2.592001282264807
    sum de = 1.0367683274392636e-18
Info: CFL hydro = 0.011104195928886073 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011104195928886073 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9582e+04 |  512 |      1 | 2.615e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.1723220573492 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.266996530658883, dt = 0.011104195928886073 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.4%)
   patch tree reduce : 1472.00 ns (0.5%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 857.00 ns  (0.3%)
   LB compute        : 305.92 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.060228715740965e-18,-4.693999095667367e-17,2.3047725837208045e-17)
    sum a = (-6.307277698172284e-17,-3.507545816294755e-17,-1.3817072486155268e-18)
    sum e = 2.592001271506099
    sum de = -8.199278929421627e-19
Info: CFL hydro = 0.011103466483334028 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011103466483334028 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9508e+04 |  512 |      1 | 2.625e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.0806536420034 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.27810072658777, dt = 0.011103466483334028 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.4%)
   patch tree reduce : 1183.00 ns (0.4%)
   gen split merge   : 675.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1070.00 ns (0.4%)
   LB compute        : 275.85 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.0210209334136096e-18,-4.750350503582301e-17,2.333753307791342e-17)
    sum a = (8.538299461988836e-17,8.073619897630557e-18,-2.2001931526682837e-17)
    sum e = 2.5920012597412994
    sum de = -5.014435047745458e-19
Info: CFL hydro = 0.011103905946038361 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011103905946038361 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9565e+04 |  512 |      1 | 2.617e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.4442910047785 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.289204193071104, dt = 0.011103905946038361 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.66 us    (1.6%)
   patch tree reduce : 1430.00 ns (0.5%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1001.00 ns (0.3%)
   LB compute        : 282.73 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.91 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.803774565631525e-18,-4.7193938210524086e-17,2.302942992554735e-17)
    sum a = (1.0229610127726607e-16,-1.0132714979571577e-16,5.914409587082226e-17)
    sum e = 2.592001247769295
    sum de = -9.893344823930228e-19
Info: CFL hydro = 0.011105514810512132 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011105514810512132 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9409e+04 |  512 |      1 | 2.638e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1515.3521152855442 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.300308099017142, dt = 0.011105514810512132 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.3%)
   patch tree reduce : 1340.00 ns (0.4%)
   gen split merge   : 757.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1179.00 ns (0.4%)
   LB compute        : 300.41 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.968858220184447e-18,-4.886545269984499e-17,2.4214273164693824e-17)
    sum a = (-9.734815492774828e-17,-9.520314224464865e-17,5.095923683029469e-17)
    sum e = 2.5920012363950247
    sum de = 1.2265037076242269e-18
Info: CFL hydro = 0.011108277367223505 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011108277367223505 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9827e+04 |  512 |      1 | 2.582e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1548.184128554575 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 11.311413613827654, dt = 0.011108277367223505 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.59 us    (1.6%)
   patch tree reduce : 1343.00 ns (0.5%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1149.00 ns (0.4%)
   LB compute        : 276.17 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1928.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.773348820901301e-18,-4.9857091111854547e-17,2.4630688114091192e-17)
    sum a = (1.3915211756303225e-16,3.8155026013675376e-17,-5.827760149457184e-17)
    sum e = 2.592001226375683
    sum de = 2.913793338554793e-19
Info: CFL hydro = 0.011112162215799326 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011112162215799326 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9852e+04 |  512 |      1 | 2.579e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1550.5307898815322 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.322521891194876, dt = 0.011112162215799326 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.5%)
   patch tree reduce : 1674.00 ns (0.6%)
   gen split merge   : 706.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 875.00 ns  (0.3%)
   LB compute        : 275.35 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.489925784280981e-18,-4.874909070168298e-17,2.3358756335439822e-17)
    sum a = (1.0127153022426726e-17,-7.34939453045369e-17,-2.5830899919032645e-17)
    sum e = 2.592001218373129
    sum de = 2.236166980751353e-19
Info: CFL hydro = 0.011113193670194392 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011113193670194392 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9941e+04 |  512 |      1 | 2.568e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1558.0544115731607 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.333634053410675, dt = 0.011113193670194392 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.6%)
   patch tree reduce : 1159.00 ns (0.4%)
   gen split merge   : 681.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 927.00 ns  (0.3%)
   LB compute        : 279.69 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.913238648735941e-18,-5.0277165243584057e-17,2.3265081267737077e-17)
    sum a = (8.506135249289337e-17,-6.235246693964136e-17,-6.722357046018424e-17)
    sum e = 2.5920012128672134
    sum de = 1.4026865606531214e-18
Info: CFL hydro = 0.011106328624158997 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011106328624158997 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9941e+04 |  512 |      1 | 2.568e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1558.200307932254 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 11.34474724708087, dt = 0.011106328624158997 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.6%)
   patch tree reduce : 1118.00 ns (0.4%)
   gen split merge   : 1073.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 871.00 ns  (0.3%)
   LB compute        : 276.42 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.154433295797347e-18,-5.085824339792766e-17,2.2278565710992514e-17)
    sum a = (-4.6410873191446434e-17,1.725377653249982e-17,-1.3300688675443872e-16)
    sum e = 2.592001210161226
    sum de = 1.1519648082658485e-18
Info: CFL hydro = 0.011101449563899926 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011101449563899926 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9800e+04 |  512 |      1 | 2.586e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1546.2258028240824 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.355853575705028, dt = 0.011101449563899926 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.4%)
   patch tree reduce : 1572.00 ns (0.5%)
   gen split merge   : 698.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 870.00 ns  (0.3%)
   LB compute        : 274.27 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (64.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.001059024707267e-18,-5.017178079241846e-17,2.044751087199037e-17)
    sum a = (-7.354224651132112e-18,-5.337063798717401e-17,-3.910934076589711e-17)
    sum e = 2.5920012105320973
    sum de = -2.574980159653073e-19
Info: CFL hydro = 0.01109858747823245 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01109858747823245 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9468e+04 |  512 |      1 | 2.630e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1519.6333899270787 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.366955025268929, dt = 0.01109858747823245 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.5%)
   patch tree reduce : 1263.00 ns (0.4%)
   gen split merge   : 715.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 852.00 ns  (0.3%)
   LB compute        : 272.30 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.170845084918497e-18,-5.117146940555872e-17,2.049288473290889e-17)
    sum a = (-3.9939243318826147e-17,9.318620094317387e-17,-2.1615521872409004e-17)
    sum e = 2.5920012139264017
    sum de = -9.825582188149884e-19
Info: CFL hydro = 0.011097746699620988 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011097746699620988 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9568e+04 |  512 |      1 | 2.617e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.0021961910516 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.378053612747161, dt = 0.011097746699620988 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.4%)
   patch tree reduce : 1398.00 ns (0.4%)
   gen split merge   : 715.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1190.00 ns (0.4%)
   LB compute        : 308.35 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.42 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.357042934250877e-18,-4.9324314164295165e-17,2.0301143578704828e-17)
    sum a = (-6.372831949652546e-18,-1.7446981359636736e-18,-1.0046651011119678e-17)
    sum e = 2.5920012201083322
    sum de = 3.9979955110402976e-19
Info: CFL hydro = 0.011098903220208978 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011098903220208978 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9946e+04 |  512 |      1 | 2.567e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1556.4289112246552 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.389151359446782, dt = 0.011098903220208978 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.3%)
   patch tree reduce : 1483.00 ns (0.5%)
   gen split merge   : 1032.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 925.00 ns  (0.3%)
   LB compute        : 296.87 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.415589851565095e-18,-4.994930250662444e-17,2.0308461943369105e-17)
    sum a = (-1.4136189777341073e-16,-1.7889010585359076e-17,-2.7803931032521764e-17)
    sum e = 2.592001228680084
    sum de = 2.710505431213761e-20
Info: CFL hydro = 0.011102006380957898 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011102006380957898 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0286e+04 |  512 |      1 | 2.524e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1583.0716150686192 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.40025026266699, dt = 0.011102006380957898 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.80 us    (1.3%)
   patch tree reduce : 1247.00 ns (0.4%)
   gen split merge   : 674.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 844.00 ns  (0.3%)
   LB compute        : 273.74 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.70 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1937.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.237644527476213e-18,-5.021715465333698e-17,1.9873751082311042e-17)
    sum a = (-9.231714513929096e-17,-5.1228552649940085e-18,-1.7498209912286676e-17)
    sum e = 2.5920012391064176
    sum de = -1.6601845766184287e-19
Info: CFL hydro = 0.011106979193758623 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011106979193758623 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0484e+04 |  512 |      1 | 2.500e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1598.9924715887437 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.411352269047947, dt = 0.011106979193758623 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1156.00 ns (0.4%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1168.00 ns (0.4%)
   LB compute        : 282.13 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.289184466985894e-18,-5.0199590578142717e-17,1.9831304567258233e-17)
    sum a = (-5.791561688236503e-17,2.5058080610484977e-18,-3.517645159531457e-17)
    sum e = 2.5920012507600387
    sum de = 6.505213034913027e-19
Info: CFL hydro = 0.011113719837903192 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011113719837903192 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9936e+04 |  512 |      1 | 2.568e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1556.9314166373222 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.422459248241706, dt = 0.011113719837903192 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.86 us    (1.3%)
   patch tree reduce : 1402.00 ns (0.5%)
   gen split merge   : 616.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 735.00 ns  (0.3%)
   LB compute        : 277.36 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.70 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.69 us    (71.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8969201209806384e-18,-4.997638045588226e-17,1.930438231143028e-17)
    sum a = (1.3711651443166357e-16,1.878185107440089e-17,-8.10406429463395e-17)
    sum e = 2.592001262952461
    sum de = 1.1926223897340549e-18
Info: CFL hydro = 0.011122103677973226 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011122103677973226 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0097e+04 |  512 |      1 | 2.548e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1570.4753143295272 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.43357296807961, dt = 0.011122103677973226 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.89 us    (1.3%)
   patch tree reduce : 1103.00 ns (0.4%)
   gen split merge   : 595.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1089.00 ns (0.4%)
   LB compute        : 273.65 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.62 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.6837533851373795e-18,-4.989221926224308e-17,1.814808069447449e-17)
    sum a = (5.0446951303795284e-17,-3.3875246358006097e-17,-6.035601705922656e-17)
    sum e = 2.592001274981879
    sum de = -1.5000953495873659e-18
Info: CFL hydro = 0.011131985140502242 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011131985140502242 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0406e+04 |  512 |      1 | 2.509e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1595.7943452202924 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.444695071757582, dt = 0.011131985140502242 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1227.00 ns (0.4%)
   gen split merge   : 721.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 869.00 ns  (0.3%)
   LB compute        : 283.88 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.591796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.6369158512860054e-18,-5.051720760457235e-17,1.757432090479516e-17)
    sum a = (-3.828602474116593e-17,1.820809128472156e-17,1.0697107262480632e-16)
    sum e = 2.5920012861785593
    sum de = -4.458569676109823e-19
Info: CFL hydro = 0.011130466555609867 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011130466555609867 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0381e+04 |  512 |      1 | 2.512e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1595.2186409148328 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.455827056898084, dt = 0.011130466555609867 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.3%)
   patch tree reduce : 1338.00 ns (0.4%)
   gen split merge   : 645.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1357.00 ns (0.4%)
   LB compute        : 299.52 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.41 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.6357635652128905e-18,-4.9907587828038055e-17,1.9629317702524184e-17)
    sum a = (5.1064621281460276e-17,5.927289908891354e-17,-7.569530939555146e-17)
    sum e = 2.592001295654278
    sum de = 5.149960319306146e-19
Info: CFL hydro = 0.01112727278345568 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01112727278345568 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9943e+04 |  512 |      1 | 2.567e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1560.7594894875572 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.466957523453694, dt = 0.01112727278345568 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.2%)
   patch tree reduce : 1434.00 ns (0.4%)
   gen split merge   : 647.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1253.00 ns (0.3%)
   LB compute        : 362.80 us  (95.5%)
   LB move op cnt    : 0
   LB apply          : 3.32 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.53 us    (70.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.490548558000462e-18,-4.9006331219632326e-17,1.791096567935191e-17)
    sum a = (5.4905299057272925e-17,-7.838261290027404e-17,3.9062503232045743e-17)
    sum e = 2.592001303093806
    sum de = 7.132017415881209e-19
Info: CFL hydro = 0.011125945288231931 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011125945288231931 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0271e+04 |  512 |      1 | 2.526e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1586.0076428148868 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.47808479623715, dt = 0.011125945288231931 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.5%)
   patch tree reduce : 1821.00 ns (0.6%)
   gen split merge   : 665.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 878.00 ns  (0.3%)
   LB compute        : 277.46 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.1374919943225625e-18,-5.058343880478405e-17,1.8904799600760745e-17)
    sum a = (1.254733621690318e-16,-5.046744272485526e-18,-4.467129791074775e-18)
    sum e = 2.592001308255533
    sum de = 1.0570971181733668e-18
Info: CFL hydro = 0.011126520933221331 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011126520933221331 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0069e+04 |  512 |      1 | 2.551e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1569.9856415407974 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.489210741525381, dt = 0.010789258474618535 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.6%)
   patch tree reduce : 2.03 us    (0.7%)
   gen split merge   : 671.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 867.00 ns  (0.3%)
   LB compute        : 265.00 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1989.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.753386912194959e-18,-5.045061048612742e-17,1.8636947454048203e-17)
    sum a = (-5.691638566701629e-17,-2.700183826531699e-17,-1.2320613279603876e-16)
    sum e = 2.592001302554909
    sum de = 5.454892180317694e-19
Info: CFL hydro = 0.011128971756325247 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011128971756325247 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0291e+04 |  512 |      1 | 2.523e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1539.3509261679317 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 1388                                                    [SPH][rank=0]
Info: time since start : 1783.871274864 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14985158104229665 max=0.15012768349678368 delta=0.00027610245448703163
Number of particle pairs: 130816
Distance min=0.141374 max=1.987516 mean=0.802571
---------------- t = 11.5, dt = 0.011128971756325247 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.23 us    (1.3%)
   patch tree reduce : 1146.00 ns (0.2%)
   gen split merge   : 423.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 832.00 ns  (0.1%)
   LB compute        : 673.02 us  (96.4%)
   LB move op cnt    : 0
   LB apply          : 5.64 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.57 us    (81.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.6205040621648546e-18,-5.070510661732766e-17,1.6639033900700538e-17)
    sum a = (-1.2719903255686837e-16,-8.287901615000592e-17,-8.785550412171438e-17)
    sum e = 2.592001311149194
    sum de = 1.5788694136820158e-18
Info: CFL hydro = 0.011133265902009939 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011133265902009939 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7318e+04 |  512 |      1 | 2.956e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1355.1636146545623 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.511128971756325, dt = 0.011133265902009939 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.3%)
   patch tree reduce : 1413.00 ns (0.4%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 943.00 ns  (0.3%)
   LB compute        : 311.46 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.843605121678362e-18,-5.207053050456517e-17,1.589256070494427e-17)
    sum a = (1.6463393148757886e-17,-1.2997415643756227e-17,-1.721630650541872e-16)
    sum e = 2.592001309178922
    sum de = -2.710505431213761e-20
Info: CFL hydro = 0.0111394777072953 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0111394777072953 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9458e+04 |  512 |      1 | 2.631e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.1550130567548 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.522262237658335, dt = 0.0111394777072953 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.5%)
   patch tree reduce : 1247.00 ns (0.4%)
   gen split merge   : 679.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 956.00 ns  (0.3%)
   LB compute        : 284.94 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.31 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.598860355031764e-18,-5.188427812385932e-17,1.3437249360079285e-17)
    sum a = (4.414730300078551e-17,6.224708248847577e-17,-1.3231603313013095e-17)
    sum e = 2.5920013050933983
    sum de = -4.336808689942018e-19
Info: CFL hydro = 0.011135010970122152 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011135010970122152 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9294e+04 |  512 |      1 | 2.654e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1511.2210995660078 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.533401715365631, dt = 0.011135010970122152 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.59 us    (1.5%)
   patch tree reduce : 1341.00 ns (0.4%)
   gen split merge   : 741.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1104.00 ns (0.4%)
   LB compute        : 282.98 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.41 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.35 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.2077482950996236e-18,-5.0824578920471986e-17,1.4198359285164108e-17)
    sum a = (2.0429946796796105e-17,-1.3489209749195652e-17,-3.184952301893418e-17)
    sum e = 2.592001299010185
    sum de = 1.4230153513872246e-19
Info: CFL hydro = 0.011126392210685345 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011126392210685345 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9920e+04 |  512 |      1 | 2.570e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1559.6038600931647 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.544536726335753, dt = 0.011126392210685345 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1110.00 ns (0.4%)
   gen split merge   : 644.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1296.00 ns (0.4%)
   LB compute        : 279.56 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.47 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.412662505699384e-18,-5.145834930039839e-17,1.3749743531243919e-17)
    sum a = (-8.595565665486804e-17,-1.0379197501464432e-16,1.4279593132937583e-17)
    sum e = 2.592001291585853
    sum de = 4.607859233063394e-19
Info: CFL hydro = 0.01111867544153339 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01111867544153339 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9934e+04 |  512 |      1 | 2.569e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1559.4627771458954 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.55566311854644, dt = 0.01111867544153339 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.91 us    (1.3%)
   patch tree reduce : 1136.00 ns (0.4%)
   gen split merge   : 693.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 832.00 ns  (0.3%)
   LB compute        : 279.69 us  (91.2%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.6562549862728665e-18,-5.316791928597353e-17,1.4088583815199952e-17)
    sum a = (1.0911974449023809e-16,5.152128723651117e-19,-5.365239502674868e-17)
    sum e = 2.592001283460023
    sum de = -7.453889935837843e-19
Info: CFL hydro = 0.01111194410651476 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01111194410651476 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9939e+04 |  512 |      1 | 2.568e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1558.8108223426336 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.566781793987973, dt = 0.01111194410651476 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.3%)
   patch tree reduce : 1341.00 ns (0.4%)
   gen split merge   : 680.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 873.00 ns  (0.2%)
   LB compute        : 354.73 us  (95.6%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.965930874318736e-18,-5.250341177445716e-17,1.3246971878808077e-17)
    sum a = (4.7973344047269606e-17,-1.0053676641197384e-16,-2.634611279139776e-18)
    sum e = 2.59200127515393
    sum de = 1.4840017235895342e-18
Info: CFL hydro = 0.011105810779772043 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011105810779772043 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9626e+04 |  512 |      1 | 2.609e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.3772529977916 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.577893738094488, dt = 0.011105810779772043 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.66 us    (1.4%)
   patch tree reduce : 1117.00 ns (0.3%)
   gen split merge   : 689.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1431.00 ns (0.4%)
   LB compute        : 309.70 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.0742426713500384e-18,-5.4217372778830875e-17,1.3536047283047026e-17)
    sum a = (-2.4273551918474466e-17,-1.8219800668184405e-17,-4.5432407835832574e-18)
    sum e = 2.5920012671577477
    sum de = -6.911788849595091e-19
Info: CFL hydro = 0.011100814510511623 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011100814510511623 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9330e+04 |  512 |      1 | 2.649e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.4703612670558 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.588999548874261, dt = 0.011100814510511623 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.4%)
   patch tree reduce : 1281.00 ns (0.4%)
   gen split merge   : 611.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1445.00 ns (0.5%)
   LB compute        : 276.12 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1980.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.6439228290905416e-18,-5.381047170349707e-17,1.3519215044319189e-17)
    sum a = (-1.3495064440927074e-17,-1.5557086868733804e-16,9.11458408747734e-17)
    sum e = 2.592001259919056
    sum de = 8.876905287225068e-19
Info: CFL hydro = 0.011097036841407464 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011097036841407464 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9609e+04 |  512 |      1 | 2.611e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1530.5629866952606 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.600100363384772, dt = 0.011097036841407464 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1298.00 ns (0.4%)
   gen split merge   : 801.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 758.00 ns  (0.3%)
   LB compute        : 284.67 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.5648844907163484e-18,-5.64202005427783e-17,1.502935959279278e-17)
    sum a = (-6.498707821878113e-19,6.405032754175366e-17,1.1070051125772196e-16)
    sum e = 2.5920012538012367
    sum de = -5.353248226647178e-19
Info: CFL hydro = 0.011094526036207112 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011094526036207112 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9483e+04 |  512 |      1 | 2.628e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1520.153428435779 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 11.61119740022618, dt = 0.011094526036207112 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.76 us    (1.6%)
   patch tree reduce : 1139.00 ns (0.4%)
   gen split merge   : 1027.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 909.00 ns  (0.3%)
   LB compute        : 276.67 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.38 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.5180469568649744e-18,-5.44135049518335e-17,1.639350276621404e-17)
    sum a = (-1.5435309280720232e-16,-5.941341169046765e-17,-5.835956717881175e-17)
    sum e = 2.5920012490631215
    sum de = 1.3552527156068805e-20
Info: CFL hydro = 0.011093323794549751 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011093323794549751 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9583e+04 |  512 |      1 | 2.615e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.645172569493 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 11.622291926262386, dt = 0.011093323794549751 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1117.00 ns (0.4%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1718.00 ns (0.6%)
   LB compute        : 279.54 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.44 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.9976021664879226e-18,-5.577472077938906e-17,1.476004377314738e-17)
    sum a = (1.3315910873945568e-16,-4.135754239076306e-17,-5.578057547112048e-17)
    sum e = 2.5920012458661583
    sum de = -1.0842021724855044e-18
Info: CFL hydro = 0.011093458155514251 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011093458155514251 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9903e+04 |  512 |      1 | 2.573e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1552.4023174560941 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.633385250056936, dt = 0.011093458155514251 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.4%)
   patch tree reduce : 1573.00 ns (0.5%)
   gen split merge   : 786.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 958.00 ns  (0.3%)
   LB compute        : 282.87 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1880.00 ns (63.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.1093708217385686e-18,-5.62167500051114e-17,1.4182990719369126e-17)
    sum a = (-1.2919548243728318e-16,3.9683100555576445e-17,-2.5350083360589638e-17)
    sum e = 2.592001244263542
    sum de = 1.3891340334970526e-18
Info: CFL hydro = 0.011094941319981596 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011094941319981596 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9009e+04 |  512 |      1 | 2.694e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1482.6967699378927 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.64447870821245, dt = 0.011094941319981596 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.5%)
   patch tree reduce : 1106.00 ns (0.4%)
   gen split merge   : 663.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 932.00 ns  (0.3%)
   LB compute        : 271.60 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.436704046344552e-18,-5.54117298920409e-17,1.3909283880925162e-17)
    sum a = (-2.8740681709549244e-17,1.408638830580067e-17,-1.1427553239622135e-16)
    sum e = 2.592001244207899
    sum de = 6.810144895924575e-19
Info: CFL hydro = 0.011097769819947392 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011097769819947392 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9655e+04 |  512 |      1 | 2.605e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.2815154965915 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.655573649532432, dt = 0.011097769819947392 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.94 us    (1.2%)
   patch tree reduce : 1208.00 ns (0.4%)
   gen split merge   : 653.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 872.00 ns  (0.3%)
   LB compute        : 325.35 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (70.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.594780723092938e-18,-5.525658056115823e-17,1.220373899591537e-17)
    sum a = (-1.0965837612952889e-16,-6.744604874597826e-17,6.817934888533883e-17)
    sum e = 2.592001245572527
    sum de = 1.8295911660692887e-19
Info: CFL hydro = 0.01110191425412554 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01110191425412554 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0470e+04 |  512 |      1 | 2.501e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1597.2786174850642 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.66667141935238, dt = 0.01110191425412554 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.6%)
   patch tree reduce : 945.00 ns  (0.3%)
   gen split merge   : 589.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1033.00 ns (0.4%)
   LB compute        : 271.46 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1980.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0227959932062056e-18,-5.652412132101103e-17,1.391221122679087e-17)
    sum a = (3.8933700013954467e-17,3.875805926201181e-18,5.482918806476444e-18)
    sum e = 2.5920012481538866
    sum de = 9.656175598699024e-19
Info: CFL hydro = 0.011107333141306712 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011107333141306712 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9648e+04 |  512 |      1 | 2.606e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.7036118767219 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.677773333606504, dt = 0.011107333141306712 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.3%)
   patch tree reduce : 1028.00 ns (0.3%)
   gen split merge   : 620.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1189.00 ns (0.4%)
   LB compute        : 287.21 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.71 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.348883670373226e-18,-5.610258351634867e-17,1.3776089644035316e-17)
    sum a = (-6.046140151039214e-17,-1.9823986202593957e-17,1.123837351305057e-16)
    sum e = 2.5920012517076905
    sum de = 4.895850435129856e-19
Info: CFL hydro = 0.011113970584377287 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011113970584377287 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9980e+04 |  512 |      1 | 2.563e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1560.4199452466949 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.688880666747812, dt = 0.011113970584377287 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.69 us    (1.2%)
   patch tree reduce : 1469.00 ns (0.5%)
   gen split merge   : 778.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 926.00 ns  (0.3%)
   LB compute        : 293.58 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.011086609743362e-18,-5.639239075705405e-17,1.5525910635263983e-17)
    sum a = (2.3594407677629548e-17,4.530945930947272e-17,5.5262435252889654e-17)
    sum e = 2.592001255959877
    sum de = -3.2271955290388843e-19
Info: CFL hydro = 0.011121753754265235 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011121753754265235 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0089e+04 |  512 |      1 | 2.549e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1569.8883003358353 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.699994637332189, dt = 0.011121753754265235 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.98 us    (1.7%)
   patch tree reduce : 1563.00 ns (0.5%)
   gen split merge   : 658.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 882.00 ns  (0.3%)
   LB compute        : 284.15 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.754632459633921e-18,-5.545564008002657e-17,1.5824865831799707e-17)
    sum a = (-1.9057021585777713e-17,4.4202922572234015e-17,-9.379216153737602e-17)
    sum e = 2.5920012606280833
    sum de = -8.511622328721651e-19
Info: CFL hydro = 0.011122581992608793 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011122581992608793 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9982e+04 |  512 |      1 | 2.562e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1562.5747397184805 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.711116391086454, dt = 0.011122581992608793 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1070.00 ns (0.4%)
   gen split merge   : 665.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 905.00 ns  (0.3%)
   LB compute        : 274.08 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1991.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3067485421801592e-18,-5.505752104228989e-17,1.385988491944129e-17)
    sum a = (1.2665454622584616e-16,6.57306240686717e-17,3.6831865682374065e-17)
    sum e = 2.5920012653193756
    sum de = -6.894848190650005e-19
Info: CFL hydro = 0.011118754297285665 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011118754297285665 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9835e+04 |  512 |      1 | 2.581e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1551.219609810831 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 11.722238973079063, dt = 0.011118754297285665 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 961.00 ns  (0.3%)
   gen split merge   : 657.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 976.00 ns  (0.3%)
   LB compute        : 280.84 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.68 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.51689467079186e-18,-5.4240791545756563e-17,1.5113154868198753e-17)
    sum a = (-6.888630291190801e-17,1.75394854889932e-16,-1.3579372001859545e-16)
    sum e = 2.592001269819989
    sum de = -1.7110065534536867e-19
Info: CFL hydro = 0.011115679544619231 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011115679544619231 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9921e+04 |  512 |      1 | 2.570e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1557.4305163203944 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.73335772737635, dt = 0.011115679544619231 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.69 us    (1.6%)
   patch tree reduce : 1020.00 ns (0.3%)
   gen split merge   : 660.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1630.00 ns (0.6%)
   LB compute        : 274.96 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1887.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.7604871513653427e-18,-5.160032557488536e-17,1.2713463094782273e-17)
    sum a = (3.2376445274762134e-17,1.0879480909914419e-16,1.1082931447581323e-17)
    sum e = 2.592001274036543
    sum de = -1.7618285302889447e-19
Info: CFL hydro = 0.011113389770830253 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011113389770830253 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9723e+04 |  512 |      1 | 2.596e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1541.521631627484 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 11.744473406920969, dt = 0.011113389770830253 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.81 us    (1.3%)
   patch tree reduce : 1047.00 ns (0.3%)
   gen split merge   : 690.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 702.00 ns  (0.2%)
   LB compute        : 288.16 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.626981527615758e-18,-5.0725049161037816e-17,1.3574834615767694e-17)
    sum a = (-1.7306468758082615e-17,4.863272870352098e-17,4.458933222650785e-17)
    sum e = 2.592001277842281
    sum de = -1.5178830414797062e-18
Info: CFL hydro = 0.011111906216368152 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011111906216368152 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9936e+04 |  512 |      1 | 2.568e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1557.805701754415 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 11.7555867966918, dt = 0.011111906216368152 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.4%)
   patch tree reduce : 910.00 ns  (0.3%)
   gen split merge   : 574.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 813.00 ns  (0.3%)
   LB compute        : 290.66 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.1468968056391765e-18,-5.0587463905349405e-17,1.4309598428061122e-17)
    sum a = (2.997309431901351e-17,1.6036878856123816e-16,-1.6615615133774854e-17)
    sum e = 2.592001281163944
    sum de = 9.0801931945661e-19
Info: CFL hydro = 0.011111239271053194 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011111239271053194 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9489e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1522.6664999057098 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.766698702908167, dt = 0.011111239271053194 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.3%)
   patch tree reduce : 1017.00 ns (0.3%)
   gen split merge   : 893.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 812.00 ns  (0.3%)
   LB compute        : 302.71 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1949.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.817259008886964e-18,-4.822509579172074e-17,1.3839759416614527e-17)
    sum a = (-3.2522812568047673e-17,4.971511483736757e-17,6.448357472987886e-17)
    sum e = 2.5920012839868587
    sum de = 1.2027867851011065e-18
Info: CFL hydro = 0.011110456420195201 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011110456420195201 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9764e+04 |  512 |      1 | 2.591e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1544.0849057710473 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.77780994217922, dt = 0.011110456420195201 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.05 us    (1.7%)
   patch tree reduce : 1154.00 ns (0.4%)
   gen split merge   : 1097.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 913.00 ns  (0.3%)
   LB compute        : 278.38 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.71 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (64.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.9771107454279466e-18,-4.8216313754123606e-17,1.4936782279789675e-17)
    sum a = (-8.705341135450962e-17,-8.053713945743723e-17,1.4701130937599948e-17)
    sum e = 2.5920012863200257
    sum de = 3.049318610115481e-19
Info: CFL hydro = 0.011106528479708729 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011106528479708729 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0045e+04 |  512 |      1 | 2.554e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1565.9111709877943 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.788920398599414, dt = 0.011106528479708729 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.79 us    (1.3%)
   patch tree reduce : 862.00 ns  (0.3%)
   gen split merge   : 567.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 567.00 ns  (0.2%)
   LB compute        : 272.11 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.71 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1968.00 ns (62.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7300614066351193e-18,-4.969462341630759e-17,1.4833593338023366e-17)
    sum a = (5.05318443339009e-17,1.4308866591594693e-16,-4.893351349122277e-17)
    sum e = 2.5920012881574834
    sum de = -1.4704491964334654e-18
Info: CFL hydro = 0.011104016773159076 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011104016773159076 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9896e+04 |  512 |      1 | 2.573e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1553.7564299869016 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.800026927079124, dt = 0.011104016773159076 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.4%)
   patch tree reduce : 1511.00 ns (0.5%)
   gen split merge   : 576.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 725.00 ns  (0.2%)
   LB compute        : 278.64 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.0854225424592483e-18,-4.6811187738582394e-17,1.3904892862126594e-17)
    sum a = (5.189306016145645e-17,-6.916147342328483e-17,8.008632819411776e-17)
    sum e = 2.592001289666327
    sum de = -8.605854744103691e-19
Info: CFL hydro = 0.011102946047833689 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011102946047833689 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9822e+04 |  512 |      1 | 2.583e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1547.5870124734167 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.811130943852282, dt = 0.011102946047833689 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1373.00 ns (0.5%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 287.75 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.6621096780042884e-18,-4.8854475152848576e-17,1.548858697547617e-17)
    sum a = (1.3026689102413336e-17,-5.936657415661628e-18,4.142779869154012e-17)
    sum e = 2.592001290936285
    sum de = 1.599198204416119e-18
Info: CFL hydro = 0.011103320205399187 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011103320205399187 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9201e+04 |  512 |      1 | 2.667e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1498.971278473039 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 11.822233889900115, dt = 0.011103320205399187 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.97 us    (1.3%)
   patch tree reduce : 1360.00 ns (0.4%)
   gen split merge   : 688.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 811.00 ns  (0.3%)
   LB compute        : 287.15 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.31 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.618199490018625e-18,-4.858515933320317e-17,1.5823768077100064e-17)
    sum a = (7.563968982410296e-17,-4.7575225009532926e-17,2.0994924548878303e-17)
    sum e = 2.5920012920470947
    sum de = 6.166399856011306e-19
Info: CFL hydro = 0.011105122164630825 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011105122164630825 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9677e+04 |  512 |      1 | 2.602e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.2138570957036 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.833337210105514, dt = 0.011105122164630825 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1053.00 ns (0.4%)
   gen split merge   : 592.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 807.00 ns  (0.3%)
   LB compute        : 281.04 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.583984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.853539445348609e-18,-4.939017944627366e-17,1.5874996629750004e-17)
    sum a = (7.846457858451394e-17,7.503958392163223e-17,-4.402435447442565e-17)
    sum e = 2.5920012930616574
    sum de = -1.294266343404571e-18
Info: CFL hydro = 0.011108314064733968 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011108314064733968 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9695e+04 |  512 |      1 | 2.600e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.847065975674 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 11.844442332270145, dt = 0.011108314064733968 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.5%)
   patch tree reduce : 1322.00 ns (0.4%)
   gen split merge   : 629.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1082.00 ns (0.4%)
   LB compute        : 285.32 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.37 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.576171875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.681978325344783e-18,-4.771281026522134e-17,1.5137305471590866e-17)
    sum a = (1.1601071665812147e-17,4.0672543458186714e-17,-1.0072850756617791e-16)
    sum e = 2.592001294012685
    sum de = 1.849919956803392e-18
Info: CFL hydro = 0.011112837377602082 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011112837377602082 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9332e+04 |  512 |      1 | 2.648e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.946278934732 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 11.855550646334878, dt = 0.011112837377602082 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.5%)
   patch tree reduce : 1420.00 ns (0.5%)
   gen split merge   : 915.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 963.00 ns  (0.3%)
   LB compute        : 277.86 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1931.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.497555535804998e-18,-4.770695557348992e-17,1.3538974628912737e-17)
    sum a = (-1.2511768964634796e-16,-3.0625892447067037e-17,-7.293774959005183e-17)
    sum e = 2.5920012949086817
    sum de = -1.917682592583736e-18
Info: CFL hydro = 0.011118614061654682 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011118614061654682 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9395e+04 |  512 |      1 | 2.640e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1515.4662474894517 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.86666348371248, dt = 0.011118614061654682 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 1156.00 ns (0.4%)
   gen split merge   : 671.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 940.00 ns  (0.3%)
   LB compute        : 278.29 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.410357933553154e-18,-4.8298279438363513e-17,1.2941796072307721e-17)
    sum a = (-5.3216220492757757e-17,-1.7260802162577527e-16,-4.147683173479078e-18)
    sum e = 2.5920012957379943
    sum de = 6.844026213814747e-19
Info: CFL hydro = 0.011125547664850573 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011125547664850573 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9747e+04 |  512 |      1 | 2.593e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1543.7387432564126 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.877782097774135, dt = 0.011125547664850573 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.18 us    (1.7%)
   patch tree reduce : 1117.00 ns (0.4%)
   gen split merge   : 765.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 959.00 ns  (0.3%)
   LB compute        : 288.13 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.006384204085055e-18,-5.0988510288951794e-17,1.337797060629864e-17)
    sum a = (-2.0774202670603702e-16,6.779147555813214e-17,-9.535243688379991e-17)
    sum e = 2.592001296451713
    sum de = -2.270048298641525e-19
Info: CFL hydro = 0.011128986680149344 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011128986680149344 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9606e+04 |  512 |      1 | 2.611e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.6816320763646 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.888907645438985, dt = 0.011128986680149344 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 1385.00 ns (0.5%)
   gen split merge   : 753.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 940.00 ns  (0.3%)
   LB compute        : 282.49 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.5128150388530345e-20,-4.8915949416028505e-17,1.1747438959097689e-17)
    sum a = (-3.260916927108615e-17,-3.794425711134419e-17,6.254567176677827e-17)
    sum e = 2.592001296894805
    sum de = 3.8624702394796095e-19
Info: CFL hydro = 0.011130962085767627 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011130962085767627 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9616e+04 |  512 |      1 | 2.610e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1534.9265532963789 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.900036632119134, dt = 0.011130962085767627 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.4%)
   patch tree reduce : 1236.00 ns (0.4%)
   gen split merge   : 720.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 934.00 ns  (0.3%)
   LB compute        : 305.20 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.640372709505349e-19,-4.995222985249015e-17,1.3389679989761483e-17)
    sum a = (8.019903100994763e-17,3.051465330417002e-17,8.58883276999567e-18)
    sum e = 2.5920012970350794
    sum de = -1.8295911660692887e-18
Info: CFL hydro = 0.011133627994965515 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011133627994965515 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9120e+04 |  512 |      1 | 2.678e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1496.4119357240588 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.911167594204901, dt = 0.011133627994965515 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.5%)
   patch tree reduce : 1284.00 ns (0.4%)
   gen split merge   : 838.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1003.00 ns (0.3%)
   LB compute        : 289.37 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2130734744774115e-18,-4.9117936280762555e-17,1.3171592722766023e-17)
    sum a = (-6.839450880646858e-17,-3.871707641989186e-17,3.895711878088015e-17)
    sum e = 2.5920012968462185
    sum de = 6.708500942254059e-19
Info: CFL hydro = 0.01113495753756107 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01113495753756107 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9321e+04 |  512 |      1 | 2.650e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1512.4860677748595 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.922301222199867, dt = 0.01113495753756107 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 1390.00 ns (0.4%)
   gen split merge   : 728.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 296.75 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.60 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.33 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.883965190078832e-19,-4.9905392318638774e-17,1.3780480662833882e-17)
    sum a = (-4.9908319664504483e-17,-9.75362368996202e-17,-8.735200063281212e-18)
    sum e = 2.5920012962314494
    sum de = -1.1655173354219173e-18
Info: CFL hydro = 0.011133127799505864 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011133127799505864 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9794e+04 |  512 |      1 | 2.587e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1549.763888214912 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 11.933436179737427, dt = 0.011133127799505864 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.17 us    (1.6%)
   patch tree reduce : 1113.00 ns (0.3%)
   gen split merge   : 799.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1004.00 ns (0.3%)
   LB compute        : 311.58 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (70.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2880321809127792e-19,-5.1348573830434227e-17,1.3460668127004971e-17)
    sum a = (-8.974510587803074e-17,-1.0442720906750357e-16,-1.3266731463401627e-17)
    sum e = 2.592001295123911
    sum de = 8.055283328388396e-19
Info: CFL hydro = 0.011132511150622857 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011132511150622857 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9519e+04 |  512 |      1 | 2.623e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.9564999459642 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.944569307536932, dt = 0.011132511150622857 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.4%)
   patch tree reduce : 1237.00 ns (0.4%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 970.00 ns  (0.3%)
   LB compute        : 296.55 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.1826477297471882e-18,-5.2613187244421324e-17,1.3271122482200193e-17)
    sum a = (8.645916014377031e-18,-3.246719299659917e-17,-1.1118059597969853e-17)
    sum e = 2.5920012936081753
    sum de = 1.0270274485458392e-18
Info: CFL hydro = 0.0111331138809525 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0111331138809525 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9465e+04 |  512 |      1 | 2.630e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.6423086741904 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.955701818687555, dt = 0.0111331138809525 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.4%)
   patch tree reduce : 1862.00 ns (0.6%)
   gen split merge   : 799.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 938.00 ns  (0.3%)
   LB compute        : 294.42 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (70.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.94251210739305e-19,-5.2654170086541274e-17,1.3114509478384661e-17)
    sum a = (-1.0824007705759197e-16,2.120377238048511e-17,2.019868647340495e-17)
    sum e = 2.5920012917260205
    sum de = -7.767292126321934e-19
Info: CFL hydro = 0.011134927535625798 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011134927535625798 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9838e+04 |  512 |      1 | 2.581e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1552.9333649594369 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.966834932568506, dt = 0.011134927535625798 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.6%)
   patch tree reduce : 1129.00 ns (0.4%)
   gen split merge   : 702.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 962.00 ns  (0.3%)
   LB compute        : 273.36 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.265765700060207e-18,-5.197795319156206e-17,1.349286893152779e-17)
    sum a = (1.0097733196476333e-16,7.263623296588362e-17,-1.477724193010843e-17)
    sum e = 2.5920012895542293
    sum de = -1.6601845766184287e-19
Info: CFL hydro = 0.011125283127551738 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011125283127551738 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0204e+04 |  512 |      1 | 2.534e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1581.8241254038392 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.977969860104132, dt = 0.011125283127551738 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 1329.00 ns (0.5%)
   gen split merge   : 769.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 976.00 ns  (0.3%)
   LB compute        : 270.31 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 3.64 us    (1.3%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.756407519426517e-19,-5.100900171001177e-17,1.3160615175769608e-17)
    sum a = (-7.570262776021574e-17,2.157161168442334e-17,1.2141459712622372e-16)
    sum e = 2.5920012869870335
    sum de = 3.8285889215894375e-19
Info: CFL hydro = 0.011114653332528403 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011114653332528403 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0025e+04 |  512 |      1 | 2.557e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1566.4525352197916 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 11.989095143231683, dt = 0.010904856768316762 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1512.00 ns (0.5%)
   gen split merge   : 867.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1010.00 ns (0.3%)
   LB compute        : 300.66 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.53 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.67 us    (73.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.016941301474784e-18,-5.094460010096613e-17,1.5243421759222887e-17)
    sum a = (-2.6823562902095197e-16,-1.3765551198918756e-16,-6.194263851844184e-17)
    sum e = 2.59200128083507
    sum de = 1.0570971181733668e-18
Info: CFL hydro = 0.011105852463520595 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011105852463520595 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9554e+04 |  512 |      1 | 2.618e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1499.32372828559 (tsim/hr)                              [sph::Model][rank=0]
Info: iteration since start : 1433                                                    [SPH][rank=0]
Info: time since start : 1785.8240823150002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14987910233317037 max=0.15011565069091815 delta=0.00023654835774777894
Number of particle pairs: 130816
Distance min=0.137743 max=1.939438 mean=0.802254
---------------- t = 12, dt = 0.011105852463520595 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.89 us    (1.6%)
   patch tree reduce : 1610.00 ns (0.3%)
   gen split merge   : 465.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 866.00 ns  (0.1%)
   LB compute        : 597.08 us  (95.7%)
   LB move op cnt    : 0
   LB apply          : 6.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.47 us    (74.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-5.895674573541676e-18,-5.3737288056854294e-17,1.358581216276411e-17)
    sum a = (-8.451247514307258e-18,6.956544715275293e-17,-3.7434898930710504e-17)
    sum e = 2.5920012819326033
    sum de = -1.362028979184915e-18
Info: CFL hydro = 0.01109857004522813 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01109857004522813 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7017e+04 |  512 |      1 | 3.009e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1328.835958811246 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.01110585246352, dt = 0.01109857004522813 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.86 us    (1.6%)
   patch tree reduce : 1337.00 ns (0.4%)
   gen split merge   : 976.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 979.00 ns  (0.3%)
   LB compute        : 289.62 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1983.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.6778986934059575e-18,-5.136028321389707e-17,1.3297834513224804e-17)
    sum a = (-1.836177694267138e-17,1.9712161590523802e-16,-1.9578089149874244e-17)
    sum e = 2.5920012797932235
    sum de = -7.284483346386983e-19
Info: CFL hydro = 0.01109317810070932 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01109317810070932 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9481e+04 |  512 |      1 | 2.628e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1520.2470089137396 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.022204422508748, dt = 0.01109317810070932 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.5%)
   patch tree reduce : 1547.00 ns (0.5%)
   gen split merge   : 843.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 291.94 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.40 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.68668073100309e-18,-4.879300088966865e-17,1.3195926285274745e-17)
    sum a = (1.1305995202548492e-16,-9.835882108788495e-19,1.5468095554416195e-16)
    sum e = 2.592001278142222
    sum de = -5.183841637196318e-19
Info: CFL hydro = 0.011089721815002614 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011089721815002614 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9779e+04 |  512 |      1 | 2.589e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.7615541096168 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.033297600609458, dt = 0.011089721815002614 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.87 us    (1.6%)
   patch tree reduce : 1125.00 ns (0.4%)
   gen split merge   : 1117.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 1241.00 ns (0.4%)
   LB compute        : 282.52 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1884.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-2.772196534828186e-18,-4.9697550762173306e-17,1.5933360587947616e-17)
    sum a = (1.4249441470520763e-16,9.375703338698748e-17,5.662657842631092e-17)
    sum e = 2.5920012771208567
    sum de = -3.3203691532368573e-19
Info: CFL hydro = 0.011088250131881599 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011088250131881599 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9710e+04 |  512 |      1 | 2.598e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.8871616122356 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.04438732242446, dt = 0.011088250131881599 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.2%)
   patch tree reduce : 1707.00 ns (0.5%)
   gen split merge   : 864.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 926.00 ns  (0.3%)
   LB compute        : 317.35 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.34 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-9.396780228931867e-19,-4.820460437066076e-17,1.6048807790526587e-17)
    sum a = (1.0462187756757335e-16,-1.1436554828159196e-16,4.6129116151871764e-17)
    sum e = 2.592001276836585
    sum de = 3.5914196963582334e-19
Info: CFL hydro = 0.011088784103064112 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011088784103064112 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9657e+04 |  512 |      1 | 2.605e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1532.5768502669378 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.055475572556343, dt = 0.011088784103064112 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.4%)
   patch tree reduce : 1137.00 ns (0.4%)
   gen split merge   : 1014.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 881.00 ns  (0.3%)
   LB compute        : 289.43 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1947.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.7271340607694085e-19,-5.057575452188656e-17,1.6488092629499824e-17)
    sum a = (3.9238143983988396e-17,-8.629815612115621e-18,2.0596805511141626e-17)
    sum e = 2.592001277354569
    sum de = -1.0028870095490916e-18
Info: CFL hydro = 0.011091320091598795 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011091320091598795 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9345e+04 |  512 |      1 | 2.647e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1508.2996662715957 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.066564356659407, dt = 0.011091320091598795 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.5%)
   patch tree reduce : 1218.00 ns (0.4%)
   gen split merge   : 721.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 961.00 ns  (0.3%)
   LB compute        : 301.79 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-1.8149544367407343e-19,-5.021569098040413e-17,1.652102527048907e-17)
    sum a = (7.42492005378903e-17,-1.6639033900700538e-17,-5.85879001563372e-17)
    sum e = 2.592001278689189
    sum de = -2.2090619264392153e-18
Info: CFL hydro = 0.011089502566493083 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011089502566493083 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9475e+04 |  512 |      1 | 2.629e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.784113506953 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.077655676751005, dt = 0.011089502566493083 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1381.00 ns (0.5%)
   gen split merge   : 882.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 921.00 ns  (0.3%)
   LB compute        : 274.69 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1938.00 ns (63.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.894429026102713e-19,-5.023325505559839e-17,1.53969244580561e-17)
    sum a = (-7.104668416080262e-18,1.2950578109904853e-17,3.513985977199319e-17)
    sum e = 2.5920012807025095
    sum de = 2.120970499924768e-18
Info: CFL hydro = 0.011082651211534771 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011082651211534771 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9544e+04 |  512 |      1 | 2.620e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.875472649136 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.088745179317499, dt = 0.011082651211534771 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.71 us    (1.6%)
   patch tree reduce : 1717.00 ns (0.6%)
   gen split merge   : 679.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 917.00 ns  (0.3%)
   LB compute        : 277.56 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1848.00 ns (64.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.605337820482667e-19,-5.006932368711858e-17,1.638106154628477e-17)
    sum a = (1.999962695453661e-17,-4.186104587966533e-17,-9.043156848353994e-17)
    sum e = 2.5920012832755734
    sum de = -5.624298769768554e-19
Info: CFL hydro = 0.011076825367854499 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011076825367854499 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9546e+04 |  512 |      1 | 2.620e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.0833426203303 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.099827830529033, dt = 0.011076825367854499 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.3%)
   patch tree reduce : 1235.00 ns (0.4%)
   gen split merge   : 863.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 927.00 ns  (0.3%)
   LB compute        : 295.01 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1976.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.630967898188735e-19,-5.0648938168529333e-17,1.4581841593572232e-17)
    sum a = (9.437763071051819e-17,1.8969201209806386e-17,-1.0860160427200727e-16)
    sum e = 2.5920012863491606
    sum de = -4.912791094074942e-19
Info: CFL hydro = 0.011072067036276513 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011072067036276513 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8894e+04 |  512 |      1 | 2.710e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1471.5467516530748 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.110904655896888, dt = 0.011072067036276513 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.14 us    (1.7%)
   patch tree reduce : 1356.00 ns (0.5%)
   gen split merge   : 792.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 958.00 ns  (0.3%)
   LB compute        : 280.91 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1962.00 ns (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0901249481175553e-18,-5.0045904920192895e-17,1.312658478008072e-17)
    sum a = (1.1185388552881204e-17,8.711781296355526e-18,1.480197800267369e-16)
    sum e = 2.59200128973442
    sum de = 2.710505431213761e-20
Info: CFL hydro = 0.011068404263682392 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011068404263682392 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9279e+04 |  512 |      1 | 2.656e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1500.9168234007825 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.121976722933166, dt = 0.011068404263682392 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.4%)
   patch tree reduce : 1576.00 ns (0.5%)
   gen split merge   : 828.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 922.00 ns  (0.3%)
   LB compute        : 278.92 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1977.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.1574539030289054e-18,-5.005468695779003e-17,1.634300605003053e-17)
    sum a = (-2.0945159669161218e-17,9.456498084592368e-17,1.937756595807305e-17)
    sum e = 2.592001293224603
    sum de = -1.3552527156068805e-20
Info: CFL hydro = 0.011065852979733901 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011065852979733901 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9421e+04 |  512 |      1 | 2.636e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1511.4005338706388 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.133045127196848, dt = 0.011065852979733901 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.3%)
   patch tree reduce : 1464.00 ns (0.5%)
   gen split merge   : 911.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 306.60 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6890785645151674e-18,-4.846513815270903e-17,1.589146295024463e-17)
    sum a = (-9.476696771065774e-17,-2.0994924548878303e-17,1.0737504635427442e-17)
    sum e = 2.592001296598981
    sum de = -3.181455749887152e-18
Info: CFL hydro = 0.011064416880795831 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011064416880795831 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9172e+04 |  512 |      1 | 2.671e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1491.6884573931757 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.144110980176581, dt = 0.011064416880795831 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.49 us    (1.4%)
   patch tree reduce : 1611.00 ns (0.5%)
   gen split merge   : 678.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 973.00 ns  (0.3%)
   LB compute        : 310.70 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.568359375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8735013540549516e-19,-4.944872636358788e-17,1.5860725818654665e-17)
    sum a = (8.268434764993616e-17,-1.9805251189053408e-16,1.2325589767575585e-16)
    sum e = 2.592001299643889
    sum de = 4.1674021004911577e-19
Info: CFL hydro = 0.01106408769269228 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01106408769269228 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7355e+04 |  512 |      1 | 2.950e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1350.1949289757797 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.155175397057377, dt = 0.01106408769269228 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.02 us    (1.5%)
   patch tree reduce : 2.12 us    (0.6%)
   gen split merge   : 809.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 944.00 ns  (0.3%)
   LB compute        : 314.79 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.44 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2101461286117006e-18,-5.2493166063927175e-17,1.79424346474083e-17)
    sum a = (-7.224396861987836e-17,-2.0468002293050346e-17,4.820167702479505e-17)
    sum e = 2.5920013021739194
    sum de = -5.590417451878382e-19
Info: CFL hydro = 0.011064855885218439 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011064855885218439 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9657e+04 |  512 |      1 | 2.605e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.1772054833707 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.166239484750069, dt = 0.011064855885218439 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1600.00 ns (0.5%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1513.00 ns (0.5%)
   LB compute        : 276.87 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1852.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.674348573820765e-19,-5.1992589920890616e-17,1.793292077334474e-17)
    sum a = (1.6715730362382163e-16,5.2317525311984523e-17,4.03446807212271e-17)
    sum e = 2.592001304036807
    sum de = -1.1849990932087662e-18
Info: CFL hydro = 0.011066691973977237 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011066691973977237 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9938e+04 |  512 |      1 | 2.568e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1551.1367864230572 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.177304340635287, dt = 0.011066691973977237 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.5%)
   patch tree reduce : 1211.00 ns (0.4%)
   gen split merge   : 667.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 992.00 ns  (0.3%)
   LB compute        : 279.76 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.547943189241564e-18,-5.0988510288951794e-17,1.8275054321399698e-17)
    sum a = (-8.125433919453639e-17,1.042720597366209e-17,-9.337647842444507e-17)
    sum e = 2.5920013051356325
    sum de = -1.5106832614280447e-18
Info: CFL hydro = 0.011069542498848447 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011069542498848447 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9308e+04 |  512 |      1 | 2.652e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1502.395610568109 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.188371032609263, dt = 0.011069542498848447 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1327.00 ns (0.4%)
   gen split merge   : 685.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 298.65 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.32 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1937.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3729252110183943e-18,-5.0947527446831843e-17,1.6571887904905798e-17)
    sum a = (3.1430912560137525e-17,-1.9771293977011162e-17,-2.763999966404196e-17)
    sum e = 2.5920013054312845
    sum de = -1.697877542771245e-18
Info: CFL hydro = 0.011073347698112265 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011073347698112265 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9107e+04 |  512 |      1 | 2.680e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1487.1614506332605 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.199440575108111, dt = 0.011073347698112265 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.72 us    (1.6%)
   patch tree reduce : 1148.00 ns (0.4%)
   gen split merge   : 624.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1118.00 ns (0.4%)
   LB compute        : 279.16 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1865.00 ns (64.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.268693045925918e-18,-5.149786846958548e-17,1.6515342102929466e-17)
    sum a = (3.7856436735372866e-17,4.421463195569686e-17,-6.551400047460909e-17)
    sum e = 2.592001304944273
    sum de = -1.3230654636112171e-18
Info: CFL hydro = 0.011078043090755297 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011078043090755297 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9657e+04 |  512 |      1 | 2.605e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1530.5180312752245 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.210513922806223, dt = 0.011078043090755297 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.3%)
   patch tree reduce : 1651.00 ns (0.5%)
   gen split merge   : 876.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 982.00 ns  (0.3%)
   LB compute        : 293.59 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.761950824298198e-18,-5.043816926619815e-17,1.5591958876359086e-17)
    sum a = (-8.825947785118249e-18,8.373965583452491e-17,-1.583108644176434e-17)
    sum e = 2.59200130376613
    sum de = -4.87890977618477e-19
Info: CFL hydro = 0.011083555405565 sink sink = inf                                   [SPH][rank=0]
Info: cfl dt = 0.011083555405565 cfl multiplier : 0.9999999999999997           [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9644e+04 |  512 |      1 | 2.606e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1530.1105197036745 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.221591965896978, dt = 0.011083555405565 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1424.00 ns (0.5%)
   gen split merge   : 637.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 890.00 ns  (0.3%)
   LB compute        : 279.06 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1866.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.37700484295722e-18,-4.9437016980125037e-17,1.5716371075651796e-17)
    sum a = (-6.517442835418664e-17,7.046999702525758e-17,-3.9542587954022324e-17)
    sum e = 2.5920013020365142
    sum de = 1.3213713977167085e-19
Info: CFL hydro = 0.011089802396266989 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011089802396266989 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9235e+04 |  512 |      1 | 2.662e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1499.0347183773692 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.232675521302543, dt = 0.011089802396266989 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.5%)
   patch tree reduce : 1276.00 ns (0.4%)
   gen split merge   : 1011.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 916.00 ns  (0.3%)
   LB compute        : 275.86 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1855.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2529040305242488e-18,-4.882812904005718e-17,1.5129255270460164e-17)
    sum a = (1.7391361788188232e-17,-5.950415941230469e-17,2.2962100970636002e-17)
    sum e = 2.592001299961044
    sum de = -2.104029840979682e-18
Info: CFL hydro = 0.011096694326028497 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011096694326028497 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9456e+04 |  512 |      1 | 2.632e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1517.094737899436 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.24376532369881, dt = 0.011096694326028497 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.3%)
   patch tree reduce : 13.35 us   (4.4%)
   gen split merge   : 700.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 834.00 ns  (0.3%)
   LB compute        : 278.13 us  (90.9%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0813429105204228e-18,-5.009274245404427e-17,1.5756439122188713e-17)
    sum a = (-2.4607269347165505e-17,1.0188920020193226e-16,-9.03378934158372e-17)
    sum e = 2.592001297763856
    sum de = 2.913793338554793e-19
Info: CFL hydro = 0.01110413582330121 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01110413582330121 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9338e+04 |  512 |      1 | 2.648e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1508.8200705089707 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.254862018024838, dt = 0.01110413582330121 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.3%)
   patch tree reduce : 2.32 us    (0.7%)
   gen split merge   : 826.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 927.00 ns  (0.3%)
   LB compute        : 300.87 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4387904929968887e-18,-4.8078728498435195e-17,1.420787315922767e-17)
    sum a = (3.0584909604947086e-17,6.157635436699477e-17,5.946024922431903e-17)
    sum e = 2.592001295687965
    sum de = -8.74138001566438e-19
Info: CFL hydro = 0.011111623395732687 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011111623395732687 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9704e+04 |  512 |      1 | 2.598e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1538.3878168076292 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.265966153848138, dt = 0.011111623395732687 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1390.00 ns (0.5%)
   gen split merge   : 690.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 920.00 ns  (0.3%)
   LB compute        : 275.83 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.56 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1878.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.1208620797075194e-18,-4.744056709971023e-17,1.5592507753708905e-17)
    sum a = (1.1095811769390451e-16,-2.401228629995977e-17,4.37930941510345e-18)
    sum e = 2.592001293970268
    sum de = -1.8634724839594607e-19
Info: CFL hydro = 0.011118337754017597 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011118337754017597 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9800e+04 |  512 |      1 | 2.586e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1546.923698282641 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.277077777243871, dt = 0.011118337754017597 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.99 us    (1.3%)
   patch tree reduce : 1346.00 ns (0.4%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 293.95 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.51 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.681137426131409e-18,-4.8418300618857655e-17,1.540881680063555e-17)
    sum a = (1.0350509511980465e-16,-7.388035495881074e-17,5.4038804681022514e-17)
    sum e = 2.592001292820403
    sum de = 1.4026865606531214e-18
Info: CFL hydro = 0.011125300347465946 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011125300347465946 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9419e+04 |  512 |      1 | 2.637e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.0934093382298 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.28819611499789, dt = 0.011125300347465946 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1108.00 ns (0.4%)
   gen split merge   : 883.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 946.00 ns  (0.3%)
   LB compute        : 280.72 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1856.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.9194047273271035e-18,-4.9442871671856456e-17,1.624530588176243e-17)
    sum a = (7.494590885392949e-17,6.170845084918497e-18,-6.536177848959213e-17)
    sum e = 2.592001292429913
    sum de = -1.5382118322138094e-18
Info: CFL hydro = 0.011132428655741754 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011132428655741754 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9424e+04 |  512 |      1 | 2.636e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1519.4500191216923 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.299321415345355, dt = 0.011132428655741754 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1166.00 ns (0.4%)
   gen split merge   : 769.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 853.00 ns  (0.3%)
   LB compute        : 293.96 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.5414657237906614e-18,-4.8962786949879875e-17,1.4780169275974143e-17)
    sum a = (2.1258385676792278e-17,-4.505185287329016e-18,5.735256020100721e-17)
    sum e = 2.592001292920368
    sum de = -4.54009659728305e-19
Info: CFL hydro = 0.011139640592776069 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011139640592776069 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9792e+04 |  512 |      1 | 2.587e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1549.1971994002138 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.310453844001097, dt = 0.011139640592776069 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.71 us    (1.5%)
   patch tree reduce : 1194.00 ns (0.4%)
   gen split merge   : 699.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 900.00 ns  (0.3%)
   LB compute        : 287.90 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.74 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1873.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.412662505699384e-18,-4.914428239355395e-17,1.6236523844165297e-17)
    sum a = (2.7107222716482583e-17,-1.069652179330749e-16,1.1226956864174297e-16)
    sum e = 2.5920012943460846
    sum de = 1.212951180468158e-18
Info: CFL hydro = 0.011146423459158365 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011146423459158365 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0302e+04 |  512 |      1 | 2.522e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1590.150666085178 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.321593484593873, dt = 0.011146423459158365 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.3%)
   patch tree reduce : 1248.00 ns (0.4%)
   gen split merge   : 991.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 864.00 ns  (0.3%)
   LB compute        : 293.51 us  (90.8%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.40 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.790290122376085e-18,-5.10177837476089e-17,1.7707515141685005e-17)
    sum a = (2.581333584383838e-17,5.0789450770083454e-17,9.260951380762883e-17)
    sum e = 2.5920012966743307
    sum de = -1.4094628242311558e-18
Info: CFL hydro = 0.011141710242652174 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011141710242652174 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0487e+04 |  512 |      1 | 2.499e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1605.6602540746344 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.33273990805303, dt = 0.011141710242652174 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.3%)
   patch tree reduce : 1356.00 ns (0.4%)
   gen split merge   : 702.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 865.00 ns  (0.3%)
   LB compute        : 289.52 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.904456611138808e-18,-4.955411081475347e-17,1.8672075604436734e-17)
    sum a = (1.239438239541979e-17,8.651477971521881e-17,4.028027911218146e-17)
    sum e = 2.5920012996232216
    sum de = -9.961107459710572e-19
Info: CFL hydro = 0.011137130079110031 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137130079110031 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0473e+04 |  512 |      1 | 2.501e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1603.8280628486946 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.343881618295683, dt = 0.011137130079110031 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1439.00 ns (0.5%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1580.00 ns (0.5%)
   LB compute        : 274.79 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.087415727745737e-18,-4.830706147596064e-17,1.8901872254895036e-17)
    sum a = (2.2705080003626587e-16,-3.9279126826108346e-17,-1.0483411014283739e-16)
    sum e = 2.5920013031875624
    sum de = 2.7037291676357267e-18
Info: CFL hydro = 0.011132737149145684 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011132737149145684 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0420e+04 |  512 |      1 | 2.507e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1599.0337393484886 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.355018748374793, dt = 0.011132737149145684 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.92 us    (1.2%)
   patch tree reduce : 1062.00 ns (0.3%)
   gen split merge   : 756.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1044.00 ns (0.3%)
   LB compute        : 303.57 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.710006236562929e-18,-4.9460435747050725e-17,1.688639462635311e-17)
    sum a = (-5.1972098499830644e-17,6.768023641523513e-18,-1.4078191737376677e-16)
    sum e = 2.592001307136733
    sum de = 1.1756817307889689e-18
Info: CFL hydro = 0.011128585501874552 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011128585501874552 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0505e+04 |  512 |      1 | 2.497e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1605.0945150896962 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.366151485523938, dt = 0.011128585501874552 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.08 us    (1.4%)
   patch tree reduce : 1325.00 ns (0.5%)
   gen split merge   : 658.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 883.00 ns  (0.3%)
   LB compute        : 271.39 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1991.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.606708232049674e-18,-4.9062316709314045e-17,1.50377757121567e-17)
    sum a = (2.2259537962865394e-17,-6.662639190357922e-17,4.997564861941584e-17)
    sum e = 2.5920013111931777
    sum de = -1.9447876468958736e-18
Info: CFL hydro = 0.01112472786037203 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01112472786037203 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0397e+04 |  512 |      1 | 2.510e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1596.0127518277677 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.377280071025812, dt = 0.01112472786037203 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.74 us    (1.3%)
   patch tree reduce : 1141.00 ns (0.4%)
   gen split merge   : 689.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 743.00 ns  (0.3%)
   LB compute        : 275.47 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.073619897630557e-18,-5.0344494198495405e-17,1.6627324517237694e-17)
    sum a = (1.6545944302170935e-16,1.4075264391510966e-16,4.6205227144380246e-17)
    sum e = 2.5920013150646604
    sum de = -2.608861477543245e-19
Info: CFL hydro = 0.011120529035101523 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011120529035101523 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0275e+04 |  512 |      1 | 2.525e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1585.899770557231 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.388404798886183, dt = 0.011120529035101523 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1465.00 ns (0.5%)
   gen split merge   : 592.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 949.00 ns  (0.3%)
   LB compute        : 273.30 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1974.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0828252357264479e-17,-4.756937031780151e-17,1.7174738194125626e-17)
    sum a = (-4.8816419656594335e-17,4.811971134055515e-17,-3.2493539109390567e-18)
    sum e = 2.592001318449575
    sum de = 9.24959978401696e-19
Info: CFL hydro = 0.011112377877015751 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011112377877015751 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0088e+04 |  512 |      1 | 2.549e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1570.739638175235 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.399525327921285, dt = 0.011112377877015751 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1345.00 ns (0.5%)
   gen split merge   : 672.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1009.00 ns (0.3%)
   LB compute        : 279.29 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.560546875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.960605694940949e-18,-4.751960543808442e-17,1.690542237448023e-17)
    sum a = (-9.523827039503718e-17,8.5004269248512e-17,-1.1010333270111694e-16)
    sum e = 2.592001321013943
    sum de = 5.30242624981192e-19
Info: CFL hydro = 0.011104244019382866 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011104244019382866 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9815e+04 |  512 |      1 | 2.584e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1548.2001093468427 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.410637705798301, dt = 0.011104244019382866 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 1842.00 ns (0.6%)
   gen split merge   : 647.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 954.00 ns  (0.3%)
   LB compute        : 277.98 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1994.00 ns (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.552734375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.748684506536651e-18,-4.643941481363711e-17,1.504948509561954e-17)
    sum a = (2.0661207120187264e-17,4.247578851146461e-18,1.020355674952178e-16)
    sum e = 2.5920013226079552
    sum de = -2.752857078576476e-18
Info: CFL hydro = 0.011096290113999154 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011096290113999154 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0037e+04 |  512 |      1 | 2.555e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1564.4516508862628 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.421741949817683, dt = 0.011096290113999154 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.6%)
   patch tree reduce : 1202.00 ns (0.4%)
   gen split merge   : 668.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 266.27 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.552734375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.801065345259706e-18,-4.679947835511955e-17,1.7414780555113917e-17)
    sum a = (-1.589548805080998e-17,-6.36844093085398e-17,-1.1310093486760487e-16)
    sum e = 2.5920013230899186
    sum de = -1.65849051072392e-18
Info: CFL hydro = 0.01108867728129629 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01108867728129629 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9900e+04 |  512 |      1 | 2.573e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1552.5939381873045 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.432838239931682, dt = 0.01108867728129629 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 1343.00 ns (0.5%)
   gen split merge   : 633.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1300.00 ns (0.4%)
   LB compute        : 280.39 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1924.00 ns (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.552734375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.284388799961739e-18,-4.7832831445715485e-17,1.4832861501556937e-17)
    sum a = (-7.76449217421149e-17,7.200831727768864e-17,4.985270009305598e-18)
    sum e = 2.5920013224033824
    sum de = 1.4693904052493975e-18
Info: CFL hydro = 0.011080806361289526 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011080806361289526 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0040e+04 |  512 |      1 | 2.555e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1562.5003948467909 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.443926917212979, dt = 0.011080806361289526 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.5%)
   patch tree reduce : 1183.00 ns (0.4%)
   gen split merge   : 650.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 968.00 ns  (0.3%)
   LB compute        : 271.72 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.552734375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.19175695558516e-18,-4.649210703921991e-17,1.569350118607593e-17)
    sum a = (-3.919716114186844e-17,6.423301221968568e-17,5.15827614996911e-17)
    sum e = 2.5920013205548367
    sum de = 2.541098841762901e-19
Info: CFL hydro = 0.011073472007148078 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011073472007148078 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9941e+04 |  512 |      1 | 2.568e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1553.624796483937 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.455007723574269, dt = 0.011073472007148078 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.4%)
   patch tree reduce : 1139.00 ns (0.4%)
   gen split merge   : 639.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1320.00 ns (0.4%)
   LB compute        : 290.29 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.38 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.552734375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.992697436716822e-18,-4.565195877576089e-17,1.6483884569817864e-17)
    sum a = (2.5175174445113414e-19,-2.138279787608499e-17,3.0876180518585313e-17)
    sum e = 2.592001317663928
    sum de = 5.099138342470888e-19
Info: CFL hydro = 0.011066927404247442 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011066927404247442 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0242e+04 |  512 |      1 | 2.529e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1576.034394066093 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.466081195581417, dt = 0.011066927404247442 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.4%)
   patch tree reduce : 1917.00 ns (0.6%)
   gen split merge   : 642.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 950.00 ns  (0.3%)
   LB compute        : 281.60 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.552734375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.243717344701527e-18,-4.6448196851234246e-17,1.6598051058580588e-17)
    sum a = (7.077736834115723e-17,-1.4181673413729555e-16,5.90635938595152e-17)
    sum e = 2.592001313915801
    sum de = 1.9989977555201488e-18
Info: CFL hydro = 0.011061319938937868 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011061319938937868 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0590e+04 |  512 |      1 | 2.487e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1602.2071755993288 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.477148122985664, dt = 0.011061319938937868 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.68 us    (1.2%)
   patch tree reduce : 1818.00 ns (0.6%)
   gen split merge   : 809.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 876.00 ns  (0.3%)
   LB compute        : 283.85 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.71 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.552734375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.177540675863292e-18,-4.864370625051739e-17,1.744990870550245e-17)
    sum a = (-1.001210832990429e-16,1.6835458808289739e-16,4.9744388296024675e-17)
    sum e = 2.5920013095710694
    sum de = 1.7448878713438587e-18
Info: CFL hydro = 0.011056783919762442 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011056783919762442 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0266e+04 |  512 |      1 | 2.526e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1576.2164347415894 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.488209442924601, dt = 0.011056783919762442 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.86 us    (1.1%)
   patch tree reduce : 989.00 ns  (0.3%)
   gen split merge   : 866.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 877.00 ns  (0.3%)
   LB compute        : 329.37 us  (95.6%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.51 us    (71.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.552734375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.112664085837493e-18,-4.491134027173604e-17,1.7927066081613317e-17)
    sum a = (-9.87452307421588e-17,1.2379160196918094e-16,-5.1814021823082254e-17)
    sum e = 2.5920013049392634
    sum de = 7.995991022080595e-19
Info: CFL hydro = 0.011053437979330758 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011053437979330758 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9788e+04 |  512 |      1 | 2.587e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1538.4073328559177 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.499266226844364, dt = 0.0007337731556358307 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.4%)
   patch tree reduce : 976.00 ns  (0.3%)
   gen split merge   : 746.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1030.00 ns (0.3%)
   LB compute        : 278.82 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1989.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.552734375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.897870082940959e-18,-4.511332713647009e-17,1.745576339723387e-17)
    sum a = (6.390396024846811e-17,-1.600087250197557e-17,-2.577235300171843e-17)
    sum e = 2.5920012180485505
    sum de = 2.3344228026328517e-18
Info: CFL hydro = 0.011053873969634186 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011053873969634186 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9913e+04 |  512 |      1 | 2.571e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 102.73603545881734 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 1479                                                    [SPH][rank=0]
Info: time since start : 1787.653661448 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14989955449875997 max=0.15010980317429726 delta=0.000210248675537289
Number of particle pairs: 130816
Distance min=0.134409 max=1.934601 mean=0.801900
---------------- t = 12.5, dt = 0.011053873969634186 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 8.99 us    (1.6%)
   patch tree reduce : 1211.00 ns (0.2%)
   gen split merge   : 742.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 865.00 ns  (0.2%)
   LB compute        : 549.33 us  (96.0%)
   LB move op cnt    : 0
   LB apply          : 3.96 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.21 us    (75.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.552734375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.735822837000694e-18,-4.540020703130976e-17,1.7309396103948328e-17)
    sum a = (9.505092025963168e-17,-7.808987831370295e-17,-1.1722263784652574e-16)
    sum e = 2.592001301397685
    sum de = -9.825582188149884e-20
Info: CFL hydro = 0.011051296398137941 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011051296398137941 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7032e+04 |  512 |      1 | 3.006e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1323.7857986567806 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.511053873969635, dt = 0.011051296398137941 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 1522.00 ns (0.5%)
   gen split merge   : 753.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1678.00 ns (0.6%)
   LB compute        : 284.63 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.552734375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.083133771694117e-18,-4.6512598460279884e-17,1.528952745660783e-17)
    sum a = (8.661430947465298e-17,5.392171084639408e-18,-7.248108363500095e-18)
    sum e = 2.5920012966226076
    sum de = -5.149960319306146e-19
Info: CFL hydro = 0.011050710675636123 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011050710675636123 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9005e+04 |  512 |      1 | 2.694e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1476.7911168218768 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.522105170367773, dt = 0.011050710675636123 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.56 us    (1.5%)
   patch tree reduce : 1195.00 ns (0.4%)
   gen split merge   : 760.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 859.00 ns  (0.3%)
   LB compute        : 295.80 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.552734375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.97011956900451e-18,-4.6047150467631857e-17,1.59013427425414e-17)
    sum a = (-7.673158983201312e-17,-9.022079958120876e-18,-8.137436037503053e-17)
    sum e = 2.592001293165302
    sum de = 8.267041565201971e-19
Info: CFL hydro = 0.011051568440995222 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011051568440995222 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9355e+04 |  512 |      1 | 2.645e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1503.86714079752 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 12.53315588104341, dt = 0.011051568440995222 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 1484.00 ns (0.5%)
   gen split merge   : 717.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 893.00 ns  (0.3%)
   LB compute        : 286.63 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.34 us    (70.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.552734375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.124062082440597e-18,-4.618180837745456e-17,1.4584037102971515e-17)
    sum a = (-4.716539658833341e-17,-6.184896345073909e-17,1.1123914289701276e-19)
    sum e = 2.5920012907318406
    sum de = 2.3649159887340065e-18
Info: CFL hydro = 0.011053908978072966 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011053908978072966 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9298e+04 |  512 |      1 | 2.653e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1499.59452571077 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 12.544207449484405, dt = 0.011053908978072966 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.70 us    (1.6%)
   patch tree reduce : 1291.00 ns (0.4%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 931.00 ns  (0.3%)
   LB compute        : 279.56 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.37 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.552734375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.646721747213119e-18,-4.720637943045336e-17,1.4982156140708192e-17)
    sum a = (1.0157890154016691e-16,1.6534820387881233e-16,-2.2306375496716766e-18)
    sum e = 2.592001289524811
    sum de = -1.0503208545953324e-18
Info: CFL hydro = 0.011057751766695658 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011057751766695658 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9323e+04 |  512 |      1 | 2.650e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1501.8221295833314 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.555261358462479, dt = 0.011057751766695658 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.5%)
   patch tree reduce : 1465.00 ns (0.5%)
   gen split merge   : 765.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 949.00 ns  (0.3%)
   LB compute        : 282.04 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1981.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.552734375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.585905424129958e-18,-4.407411935414274e-17,1.5192925043039373e-17)
    sum a = (-1.6082838186215475e-17,-4.508112633194728e-19,-7.512154960587214e-17)
    sum e = 2.592001289685456
    sum de = 2.778268066994105e-19
Info: CFL hydro = 0.011063093770065771 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011063093770065771 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9549e+04 |  512 |      1 | 2.619e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1519.950963448139 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.566319110229175, dt = 0.011063093770065771 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.5%)
   patch tree reduce : 1359.00 ns (0.5%)
   gen split merge   : 712.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 916.00 ns  (0.3%)
   LB compute        : 281.64 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1874.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.544921875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.756917666783964e-18,-4.491134027173604e-17,1.3834636561349534e-17)
    sum a = (-1.2745078430131952e-16,-1.3074697574610993e-16,-9.28729749355428e-17)
    sum e = 2.592001291268102
    sum de = -3.5914196963582334e-19
Info: CFL hydro = 0.011069909638886448 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011069909638886448 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9332e+04 |  512 |      1 | 2.649e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1503.7573252927607 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.57738220399924, dt = 0.011069909638886448 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.3%)
   patch tree reduce : 1712.00 ns (0.5%)
   gen split merge   : 781.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 851.00 ns  (0.3%)
   LB compute        : 307.35 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.40 us    (71.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.544921875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.777254285317841e-18,-4.7130268437944877e-17,1.2640279448139502e-17)
    sum a = (1.9671764217576992e-17,2.8161067228138492e-18,-1.1065367372387058e-17)
    sum e = 2.592001294234835
    sum de = 1.8295911660692887e-19
Info: CFL hydro = 0.01107815192038604 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01107815192038604 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9698e+04 |  512 |      1 | 2.599e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.1702034406821 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.588452113638127, dt = 0.01107815192038604 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.6%)
   patch tree reduce : 1106.00 ns (0.4%)
   gen split merge   : 778.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 276.06 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1972.00 ns (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.544921875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.864900493766882e-18,-4.629890221208299e-17,1.3045716850540457e-17)
    sum a = (-9.541976583871126e-17,-1.607112880275263e-17,-1.0506829781209425e-16)
    sum e = 2.5920012984577676
    sum de = -3.7947076036992655e-19
Info: CFL hydro = 0.011087759002638564 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011087759002638564 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9771e+04 |  512 |      1 | 2.590e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1540.0498650914672 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.599530265558514, dt = 0.011087759002638564 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.65 us    (1.6%)
   patch tree reduce : 1465.00 ns (0.5%)
   gen split merge   : 925.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 947.00 ns  (0.3%)
   LB compute        : 273.15 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.544921875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.071260794110854e-18,-4.6474542964025643e-17,1.1293700349912505e-17)
    sum a = (9.572420980874518e-18,1.320818454608741e-16,2.995845758968496e-17)
    sum e = 2.592001303727299
    sum de = -2.236166980751353e-19
Info: CFL hydro = 0.011098634677303978 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011098634677303978 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9675e+04 |  512 |      1 | 2.602e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.863385151797 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.610618024561152, dt = 0.011098634677303978 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.56 us    (1.5%)
   patch tree reduce : 1269.00 ns (0.4%)
   gen split merge   : 825.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 935.00 ns  (0.3%)
   LB compute        : 291.07 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.544921875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.816270316934269e-18,-4.427317887301108e-17,1.2514403575913935e-17)
    sum a = (-6.909707181423919e-17,1.0379197501464432e-16,9.890330741890718e-17)
    sum e = 2.5920013097633112
    sum de = -7.047314121155779e-19
Info: CFL hydro = 0.011110665500297563 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011110665500297563 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9546e+04 |  512 |      1 | 2.620e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1525.2942083491469 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.621716659238455, dt = 0.011110665500297563 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.3%)
   patch tree reduce : 1466.00 ns (0.5%)
   gen split merge   : 722.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 877.00 ns  (0.3%)
   LB compute        : 285.50 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.544921875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.551290984713963e-18,-4.326617189520654e-17,1.3904892862126594e-17)
    sum a = (1.6393136847980827e-19,-4.981757194266745e-17,4.343010326368635e-17)
    sum e = 2.5920013162307387
    sum de = 6.505213034913027e-19
Info: CFL hydro = 0.011123721898609109 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011123721898609109 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9847e+04 |  512 |      1 | 2.580e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1550.4796853652542 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.632827324738752, dt = 0.011123721898609109 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.5%)
   patch tree reduce : 1763.00 ns (0.6%)
   gen split merge   : 720.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 943.00 ns  (0.3%)
   LB compute        : 276.24 us  (90.5%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.544921875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.9995408204009385e-18,-4.459518691823927e-17,1.4064433211807835e-17)
    sum a = (-7.68077008245216e-17,5.537367439578666e-17,3.0292175018376e-17)
    sum e = 2.5920013227670533
    sum de = 9.486769009248164e-20
Info: CFL hydro = 0.011137657600185761 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137657600185761 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9883e+04 |  512 |      1 | 2.575e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1555.1353921287666 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.643951046637362, dt = 0.011137657600185761 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.4%)
   patch tree reduce : 1550.00 ns (0.5%)
   gen split merge   : 751.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 978.00 ns  (0.3%)
   LB compute        : 274.94 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.544921875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.854216750441564e-18,-4.3418393880223505e-17,1.4412787369827427e-17)
    sum a = (-5.103534782280317e-17,-1.0596406564700178e-16,-1.5169506276113685e-16)
    sum e = 2.592001329003705
    sum de = 2.757939276260002e-18
Info: CFL hydro = 0.011146787748175206 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011146787748175206 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9795e+04 |  512 |      1 | 2.586e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1550.2183153863316 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.655088704237548, dt = 0.011146787748175206 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.5%)
   patch tree reduce : 1209.00 ns (0.4%)
   gen split merge   : 675.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1348.00 ns (0.5%)
   LB compute        : 269.71 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1909.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.544921875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.495250963658769e-18,-4.550851882834106e-17,1.1773785071889086e-17)
    sum a = (-3.711874557721373e-18,-1.2377403789398667e-16,-1.2120382822389252e-16)
    sum e = 2.592001334488832
    sum de = 1.3383120566617945e-18
Info: CFL hydro = 0.011150041214473135 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011150041214473135 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0081e+04 |  512 |      1 | 2.550e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1573.8973981058111 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.666235491985722, dt = 0.011150041214473135 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.5%)
   patch tree reduce : 1224.00 ns (0.4%)
   gen split merge   : 725.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 973.00 ns  (0.3%)
   LB compute        : 287.64 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.44 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.544921875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.846532467544073e-18,-4.693706361080796e-17,1.0539908789491958e-17)
    sum a = (3.148067743985461e-17,-2.2110243323714142e-17,-4.461275099343353e-18)
    sum e = 2.5920013388824845
    sum de = -1.8420849020412897e-18
Info: CFL hydro = 0.011154322809256819 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011154322809256819 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9643e+04 |  512 |      1 | 2.607e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1539.9846037444463 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.677385533200194, dt = 0.011154322809256819 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.6%)
   patch tree reduce : 1278.00 ns (0.4%)
   gen split merge   : 878.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 270.98 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.56 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.544921875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.33100820831922e-18,-4.6708730633282515e-17,1.1219053030336878e-17)
    sum a = (-4.2838779398812754e-17,3.448852531687252e-17,4.2153780466236414e-17)
    sum e = 2.592001342076104
    sum de = 3.5575383784680614e-19
Info: CFL hydro = 0.011159584660234822 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011159584660234822 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9315e+04 |  512 |      1 | 2.651e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1514.830631756243 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.68853985600945, dt = 0.011159584660234822 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.5%)
   patch tree reduce : 1371.00 ns (0.5%)
   gen split merge   : 1206.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 956.00 ns  (0.3%)
   LB compute        : 281.11 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.544921875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.4454860839416845e-18,-4.5830526873569254e-17,1.1858678101994701e-17)
    sum a = (-8.979340708481498e-17,-6.252115524515295e-17,1.0575915143640202e-16)
    sum e = 2.592001343928
    sum de = 1.8397555614363403e-18
Info: CFL hydro = 0.011165767795274152 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011165767795274152 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9652e+04 |  512 |      1 | 2.605e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1541.9817143411462 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.699699440669685, dt = 0.011165767795274152 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.5%)
   patch tree reduce : 1373.00 ns (0.5%)
   gen split merge   : 686.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1114.00 ns (0.4%)
   LB compute        : 274.06 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.544921875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.1772134876224537e-18,-4.7112704362750614e-17,1.3367724895768652e-17)
    sum a = (5.553760576426648e-17,-7.789667348656603e-18,-3.501105655390191e-18)
    sum e = 2.5920013443900127
    sum de = -2.761327408049019e-19
Info: CFL hydro = 0.011162828017773591 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011162828017773591 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9960e+04 |  512 |      1 | 2.565e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1567.073985217909 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.71086520846496, dt = 0.011162828017773591 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.5%)
   patch tree reduce : 1663.00 ns (0.5%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 935.00 ns  (0.3%)
   LB compute        : 286.06 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.544921875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.579412157297956e-18,-4.679655100925384e-17,1.2663698215065188e-17)
    sum a = (1.2696484488761152e-16,-2.7604871513653427e-17,3.808476971289831e-17)
    sum e = 2.5920013433129414
    sum de = -5.454892180317694e-19
Info: CFL hydro = 0.011159689234467255 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011159689234467255 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9664e+04 |  512 |      1 | 2.604e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1543.3627391521675 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.722028036482733, dt = 0.011159689234467255 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.78 us    (1.6%)
   patch tree reduce : 1554.00 ns (0.5%)
   gen split merge   : 1046.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 1087.00 ns (0.4%)
   LB compute        : 271.86 us  (93.7%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.6519730302212464e-18,-4.751667809221871e-17,1.3376506933365783e-17)
    sum a = (1.7344524254336857e-16,-1.0646171444417263e-16,-1.3126218861847505e-17)
    sum e = 2.592001341016024
    sum de = -4.70950318673391e-19
Info: CFL hydro = 0.011156714075079323 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011156714075079323 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9863e+04 |  512 |      1 | 2.578e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1558.5863676490173 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.733187725717201, dt = 0.011156714075079323 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.5%)
   patch tree reduce : 1261.00 ns (0.4%)
   gen split merge   : 713.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 953.00 ns  (0.3%)
   LB compute        : 283.36 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.943353006606424e-18,-4.888667595737139e-17,1.2905204248986335e-17)
    sum a = (8.587076362476243e-17,5.598256233585452e-17,-4.451322123399937e-17)
    sum e = 2.5920013377286995
    sum de = -5.590417451878382e-19
Info: CFL hydro = 0.011153930802164622 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011153930802164622 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9678e+04 |  512 |      1 | 2.602e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1543.6504738155716 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.74434443979228, dt = 0.011153930802164622 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.5%)
   patch tree reduce : 1403.00 ns (0.5%)
   gen split merge   : 676.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1006.00 ns (0.4%)
   LB compute        : 269.68 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.398555288724462e-18,-4.772159230281847e-17,1.2341690169836993e-17)
    sum a = (4.116433756362614e-17,-2.0895394789444133e-17,-3.3158046620906934e-17)
    sum e = 2.592001333735913
    sum de = -2.0735366548785272e-18
Info: CFL hydro = 0.011151367300253215 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011151367300253215 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9929e+04 |  512 |      1 | 2.569e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1562.9255130961812 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.755498370594445, dt = 0.011151367300253215 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1304.00 ns (0.4%)
   gen split merge   : 670.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1382.00 ns (0.5%)
   LB compute        : 270.90 us  (89.8%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.439538130844414e-18,-4.8242659866915e-17,1.199040866595169e-17)
    sum a = (3.705434396816809e-17,9.234605267971485e-17,-6.6919126490150306e-18)
    sum e = 2.592001329362141
    sum de = -1.260385025514399e-18
Info: CFL hydro = 0.011149051180420633 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011149051180420633 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9568e+04 |  512 |      1 | 2.617e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1534.2744184923047 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.766649737894697, dt = 0.011149051180420633 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.4%)
   patch tree reduce : 1123.00 ns (0.4%)
   gen split merge   : 746.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 289.94 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.773255559535453e-18,-4.633403036247152e-17,1.198748132008598e-17)
    sum a = (-1.1155529625050952e-16,4.683753385137379e-19,1.2616275212040672e-16)
    sum e = 2.5920013249466924
    sum de = 7.995991022080595e-19
Info: CFL hydro = 0.011147009003007802 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011147009003007802 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9919e+04 |  512 |      1 | 2.570e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1561.5192209851448 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.777798789075119, dt = 0.011147009003007802 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.5%)
   patch tree reduce : 1420.00 ns (0.5%)
   gen split merge   : 643.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 955.00 ns  (0.3%)
   LB compute        : 261.91 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.447479269228174e-18,-4.72180888139162e-17,1.4170549499439856e-17)
    sum a = (4.959509365687342e-17,-5.0326930123301136e-17,-5.795559344934365e-17)
    sum e = 2.5920013208085075
    sum de = -3.9979955110402976e-19
Info: CFL hydro = 0.01114526618336251 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114526618336251 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9970e+04 |  512 |      1 | 2.564e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1565.200523684382 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.788945798078126, dt = 0.01114526618336251 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1376.00 ns (0.5%)
   gen split merge   : 637.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1378.00 ns (0.5%)
   LB compute        : 283.74 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1976.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.230232901446088e-18,-4.772159230281847e-17,1.2411214634147626e-17)
    sum a = (-4.02100228114044e-17,-1.0171941414172103e-16,-1.5626172231164582e-17)
    sum e = 2.592001317231508
    sum de = -4.675621868843738e-19
Info: CFL hydro = 0.011143846723046955 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011143846723046955 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0062e+04 |  512 |      1 | 2.552e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1572.197073151069 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.800091064261489, dt = 0.011143846723046955 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 2.27 us    (0.8%)
   gen split merge   : 790.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 947.00 ns  (0.3%)
   LB compute        : 275.50 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1885.00 ns (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.135405547670226e-18,-4.939017944627366e-17,1.2585391713157424e-17)
    sum a = (-2.3553424835509594e-17,-2.0842702563861338e-17,3.949575042017095e-17)
    sum e = 2.5920013144471423
    sum de = -5.421010862427522e-19
Info: CFL hydro = 0.011142773231052772 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011142773231052772 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9543e+04 |  512 |      1 | 2.620e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.2763053072613 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.811234910984536, dt = 0.011142773231052772 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.59 us    (1.5%)
   patch tree reduce : 1425.00 ns (0.5%)
   gen split merge   : 734.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1022.00 ns (0.3%)
   LB compute        : 291.95 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.896826859614791e-18,-4.913257301009111e-17,1.3376506933365783e-17)
    sum a = (-5.758089317853266e-17,3.6369345035591747e-17,-7.068369327345447e-17)
    sum e = 2.592001312619691
    sum de = -4.607859233063394e-19
Info: CFL hydro = 0.01114206586617505 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114206586617505 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9422e+04 |  512 |      1 | 2.636e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1521.6940934539957 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.822377684215589, dt = 0.01114206586617505 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.6%)
   patch tree reduce : 1734.00 ns (0.6%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 949.00 ns  (0.3%)
   LB compute        : 271.18 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.982031276580147e-18,-4.8318770859423485e-17,1.189087890651752e-17)
    sum a = (-1.2079985449442443e-16,-5.205991887580197e-17,1.7903647314687632e-17)
    sum e = 2.592001311834319
    sum de = -1.7550522667109103e-18
Info: CFL hydro = 0.011141742563006232 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011141742563006232 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8815e+04 |  512 |      1 | 2.721e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1473.9866702224638 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.833519750081763, dt = 0.011141742563006232 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.5%)
   patch tree reduce : 1190.00 ns (0.4%)
   gen split merge   : 1112.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 959.00 ns  (0.3%)
   LB compute        : 278.38 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.464202445209064e-18,-4.939310679213937e-17,1.25927100778217e-17)
    sum a = (-1.0688325224883499e-16,-7.671988044855027e-17,-1.6775155483456095e-17)
    sum e = 2.592001312092785
    sum de = -1.98544522836408e-18
Info: CFL hydro = 0.01114181863305129 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114181863305129 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9519e+04 |  512 |      1 | 2.623e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.1360858112246 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.84466149264477, dt = 0.01114181863305129 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.08 us    (1.3%)
   patch tree reduce : 1545.00 ns (0.5%)
   gen split merge   : 742.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 998.00 ns  (0.3%)
   LB compute        : 298.18 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.284482061327587e-18,-5.032985746916685e-17,1.230802569238132e-17)
    sum a = (1.1615122925967559e-16,-1.323043237466681e-16,-3.203980050020538e-17)
    sum e = 2.5920013133173483
    sum de = 1.3552527156068805e-20
Info: CFL hydro = 0.01114230667256825 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114230667256825 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9271e+04 |  512 |      1 | 2.657e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.7314084433087 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.855803311277821, dt = 0.01114230667256825 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1190.00 ns (0.4%)
   gen split merge   : 734.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1005.00 ns (0.3%)
   LB compute        : 275.70 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.0537512502900624e-18,-5.213602986831045e-17,1.180159485761334e-17)
    sum a = (2.150428272951199e-17,6.931955010003321e-18,-1.4040941261235507e-16)
    sum e = 2.5920013153603594
    sum de = 4.743384504624082e-19
Info: CFL hydro = 0.011143215751458924 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011143215751458924 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9566e+04 |  512 |      1 | 2.617e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1532.8559762279845 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.866945617950389, dt = 0.011143215751458924 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1373.00 ns (0.5%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 962.00 ns  (0.3%)
   LB compute        : 277.01 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1949.00 ns (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.607331005769156e-18,-5.1333937101105673e-17,9.698296853100085e-18)
    sum a = (-2.3576843602435282e-17,4.2130361699310726e-17,1.9693719311569822e-17)
    sum e = 2.592001318023339
    sum de = 2.5139937874507634e-18
Info: CFL hydro = 0.011144257786966103 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011144257786966103 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9780e+04 |  512 |      1 | 2.588e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1549.7807894404607 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.878088833701847, dt = 0.011144257786966103 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.02 us    (1.4%)
   patch tree reduce : 1394.00 ns (0.5%)
   gen split merge   : 631.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 837.00 ns  (0.3%)
   LB compute        : 278.38 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1882.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.1023638439340324e-18,-5.0792378115949163e-17,1.0755068710621706e-17)
    sum a = (6.164404924013933e-17,-8.813652932482263e-17,-3.63020160806804e-17)
    sum e = 2.592001321065239
    sum de = -1.5585406229479126e-19
Info: CFL hydro = 0.011144465537323444 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011144465537323444 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9760e+04 |  512 |      1 | 2.591e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1548.3357266846033 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.889233091488814, dt = 0.011144465537323444 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.3%)
   patch tree reduce : 1232.00 ns (0.4%)
   gen split merge   : 814.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1365.00 ns (0.4%)
   LB compute        : 296.21 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.257201787956967e-18,-5.229703389092455e-17,9.95297594341693e-18)
    sum a = (-1.206066496672875e-17,-1.3627380474057205e-16,7.302264262015745e-18)
    sum e = 2.592001324218062
    sum de = 1.311207002349657e-18
Info: CFL hydro = 0.011140879626279238 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011140879626279238 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8986e+04 |  512 |      1 | 2.697e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1487.738158519031 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.900377557026138, dt = 0.011140879626279238 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 1505.00 ns (0.5%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 970.00 ns  (0.3%)
   LB compute        : 280.07 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.8444460208917355e-18,-5.388658269600555e-17,1.0374513748079295e-17)
    sum a = (7.111108576984826e-17,-6.019794038247816e-17,-1.0503975618990357e-16)
    sum e = 2.5920013271888793
    sum de = -5.72594272343907e-19
Info: CFL hydro = 0.011134750869114743 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011134750869114743 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9416e+04 |  512 |      1 | 2.637e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1520.918319384666 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.911518436652416, dt = 0.011134750869114743 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.3%)
   patch tree reduce : 1383.00 ns (0.4%)
   gen split merge   : 843.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 956.00 ns  (0.3%)
   LB compute        : 294.88 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1939.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.970010506257563e-18,-5.4316902538265045e-17,8.53394503501359e-18)
    sum a = (-3.285067530500729e-17,3.56550726443583e-17,-4.6228645911305934e-17)
    sum e = 2.5920013297740367
    sum de = -2.016785447412489e-18
Info: CFL hydro = 0.011129309071908695 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011129309071908695 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9521e+04 |  512 |      1 | 2.623e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.3556863936228 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.922653187521531, dt = 0.011129309071908695 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.08 us    (1.4%)
   patch tree reduce : 1847.00 ns (0.6%)
   gen split merge   : 644.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 882.00 ns  (0.3%)
   LB compute        : 269.86 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.48 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1791.00 ns (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.19865487064275e-18,-5.3339169019117614e-17,8.315125931551703e-18)
    sum a = (-8.225841882647523e-18,-4.1790789578888265e-17,1.0326679087042413e-16)
    sum e = 2.592001331851786
    sum de = 2.135475939146498e-18
Info: CFL hydro = 0.011125125647439121 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011125125647439121 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9549e+04 |  512 |      1 | 2.619e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.7662455782836 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.93378249659344, dt = 0.011125125647439121 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.3%)
   patch tree reduce : 1531.00 ns (0.5%)
   gen split merge   : 783.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 922.00 ns  (0.3%)
   LB compute        : 293.30 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1848.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.0771700172157494e-18,-5.427006500441367e-17,1.0357681509351457e-17)
    sum a = (-5.385145454561702e-17,-3.722413002837932e-17,-3.9709400928588693e-17)
    sum e = 2.592001333318232
    sum de = -1.4738373282224826e-19
Info: CFL hydro = 0.011122228016231027 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011122228016231027 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8598e+04 |  512 |      1 | 2.753e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1454.7818349811776 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.944907622240878, dt = 0.011122228016231027 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1383.00 ns (0.4%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1453.00 ns (0.5%)
   LB compute        : 292.31 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.299959689869515e-18,-5.448668859847627e-17,9.154542358544293e-18)
    sum a = (2.1267753183562555e-16,3.175584795123143e-17,-2.719431125598748e-17)
    sum e = 2.592001334128262
    sum de = -7.132017415881209e-19
Info: CFL hydro = 0.011120624674181748 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011120624674181748 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9078e+04 |  512 |      1 | 2.684e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1491.9425218797949 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.956029850257108, dt = 0.011120624674181748 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.05 us    (1.7%)
   patch tree reduce : 1329.00 ns (0.4%)
   gen split merge   : 935.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 284.05 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1926.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.130391755152178e-18,-5.3939274921588344e-17,8.922550198686706e-18)
    sum a = (-8.912011753570148e-17,-1.0894410373829544e-16,4.5525351067068896e-17)
    sum e = 2.592001334305463
    sum de = -8.605854744103691e-19
Info: CFL hydro = 0.011120305228426958 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011120305228426958 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8935e+04 |  512 |      1 | 2.704e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1480.5333239987026 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 12.967150474931291, dt = 0.011120305228426958 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1339.00 ns (0.4%)
   gen split merge   : 679.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1408.00 ns (0.5%)
   LB compute        : 283.75 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1867.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.460652325623872e-18,-5.595914356892883e-17,9.936875541155521e-18)
    sum a = (-5.330404086872908e-17,5.641288217811402e-17,-2.8336707980081143e-18)
    sum e = 2.5920013339342676
    sum de = 1.463672932855431e-18
Info: CFL hydro = 0.011121242321982833 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011121242321982833 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8440e+04 |  512 |      1 | 2.777e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1441.821004749251 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.978270780159718, dt = 0.011121242321982833 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.90 us    (1.6%)
   patch tree reduce : 1263.00 ns (0.4%)
   gen split merge   : 1091.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 280.09 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1968.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.217682618769871e-18,-5.4264210312682245e-17,9.472159384973922e-18)
    sum a = (1.6596294651061161e-16,-2.157658817239505e-16,2.8541622190680902e-19)
    sum e = 2.5920013331552254
    sum de = -1.4026865606531214e-18
Info: CFL hydro = 0.011123393027482956 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011123393027482956 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9159e+04 |  512 |      1 | 2.672e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1498.166823867234 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 12.9893920224817, dt = 0.01060797751829945 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.01 us    (1.6%)
   patch tree reduce : 1254.00 ns (0.4%)
   gen split merge   : 831.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1292.00 ns (0.4%)
   LB compute        : 293.40 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.32 us    (70.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.03378934158372e-18,-5.823661865245189e-17,9.530706302288138e-18)
    sum a = (4.908280813037402e-17,1.307777128776999e-16,6.259543664649536e-17)
    sum e = 2.5920013242859676
    sum de = 9.215718466126788e-19
Info: CFL hydro = 0.011124581126056564 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011124581126056564 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9155e+04 |  512 |      1 | 2.673e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1428.7477149045017 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 1524                                                    [SPH][rank=0]
Info: time since start : 1789.46738208 (s)                                            [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.1498919295120851 max=0.1501140326871102 delta=0.0002221031750251068
Number of particle pairs: 130816
Distance min=0.132174 max=1.984509 mean=0.801474
---------------- t = 13, dt = 0.011124581126056564 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 8.89 us    (1.7%)
   patch tree reduce : 1257.00 ns (0.2%)
   gen split merge   : 745.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 852.00 ns  (0.2%)
   LB compute        : 493.18 us  (95.7%)
   LB move op cnt    : 0
   LB apply          : 3.99 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.77 us    (78.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.910840815223864e-18,-5.475600441812167e-17,1.0513562676700561e-17)
    sum a = (2.5994831287512453e-17,6.166161331533359e-17,3.7177292494527945e-19)
    sum e = 2.592001331055593
    sum de = -4.2012834183813297e-19
Info: CFL hydro = 0.011125961089988078 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011125961089988078 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6955e+04 |  512 |      1 | 3.020e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1326.2093084723238 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.011124581126056, dt = 0.011125961089988078 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1481.00 ns (0.5%)
   gen split merge   : 693.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 931.00 ns  (0.3%)
   LB compute        : 281.89 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1979.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.039644033315142e-18,-5.453352613232765e-17,1.0184968103274517e-17)
    sum a = (-3.600342680237789e-17,-1.0648220586523261e-17,7.822453622352566e-17)
    sum e = 2.5920013301588454
    sum de = 5.55653613398821e-19
Info: CFL hydro = 0.011127199431677011 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011127199431677011 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9866e+04 |  512 |      1 | 2.577e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1554.088226870494 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 13.022250542216044, dt = 0.011127199431677011 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.4%)
   patch tree reduce : 1021.00 ns (0.4%)
   gen split merge   : 721.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1013.00 ns (0.3%)
   LB compute        : 275.50 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.31 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.3546451007388e-18,-5.4823333373033024e-17,1.1411526021007367e-17)
    sum a = (-2.0823089346561073e-16,-3.238815465822498e-17,-1.9499050811500053e-17)
    sum e = 2.592001329590129
    sum de = 3.2526065174565133e-19
Info: CFL hydro = 0.01112794238412747 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01112794238412747 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9700e+04 |  512 |      1 | 2.599e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1541.268669097936 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 13.03337774164772, dt = 0.01112794238412747 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.3%)
   patch tree reduce : 1302.00 ns (0.4%)
   gen split merge   : 715.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 858.00 ns  (0.3%)
   LB compute        : 295.13 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.108218535665454e-18,-5.5306345440875314e-17,1.0753605037688851e-17)
    sum a = (-1.7609302687890404e-16,-5.883965190078832e-18,-2.1331862058021623e-16)
    sum e = 2.5920013295333297
    sum de = 3.198396408832238e-18
Info: CFL hydro = 0.011129308466892515 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011129308466892515 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9625e+04 |  512 |      1 | 2.609e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1535.4875625185016 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.044505684031849, dt = 0.011129308466892515 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1173.00 ns (0.4%)
   gen split merge   : 918.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1105.00 ns (0.4%)
   LB compute        : 281.37 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1956.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.1673882266991525e-18,-5.5338546245398136e-17,7.246644690567238e-18)
    sum a = (7.867827483271083e-17,-7.877487724627929e-17,9.806608650131388e-18)
    sum e = 2.5920013301197353
    sum de = 4.472333961502706e-19
Info: CFL hydro = 0.011131267039833371 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011131267039833371 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9593e+04 |  512 |      1 | 2.613e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.212267838421 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 13.055634992498742, dt = 0.011131267039833371 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.70 us    (1.5%)
   patch tree reduce : 1391.00 ns (0.4%)
   gen split merge   : 836.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 952.00 ns  (0.3%)
   LB compute        : 294.59 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.509264919267842e-18,-5.642751890744258e-17,8.663480089571295e-18)
    sum a = (2.164999136997775e-16,-1.1349319921361011e-16,-4.364087216601753e-17)
    sum e = 2.592001331404469
    sum de = 2.507217523872729e-19
Info: CFL hydro = 0.011133776597198535 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011133776597198535 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9162e+04 |  512 |      1 | 2.672e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1499.7671839204145 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.066766259538575, dt = 0.011133776597198535 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.4%)
   patch tree reduce : 1392.00 ns (0.4%)
   gen split merge   : 633.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1010.00 ns (0.3%)
   LB compute        : 303.18 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.41 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.609324191055645e-18,-5.812245216368917e-17,7.897979145687906e-18)
    sum a = (-6.383114252005856e-17,6.759827073099523e-17,1.4250319674280477e-17)
    sum e = 2.592001333376421
    sum de = 1.0842021724855044e-18
Info: CFL hydro = 0.011136786895837398 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011136786895837398 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9257e+04 |  512 |      1 | 2.659e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1507.5225218551868 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.077900036135773, dt = 0.011136786895837398 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.3%)
   patch tree reduce : 1404.00 ns (0.4%)
   gen split merge   : 685.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1042.00 ns (0.3%)
   LB compute        : 304.92 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.440160904563896e-18,-5.628407896002275e-17,8.30634389395457e-18)
    sum a = (-1.851301094845867e-16,-5.911482241216514e-17,6.043212805173504e-17)
    sum e = 2.5920013359583693
    sum de = 1.768604793866979e-18
Info: CFL hydro = 0.011140239949636735 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011140239949636735 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9260e+04 |  512 |      1 | 2.658e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1508.1264926128717 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.089036823031611, dt = 0.011140239949636735 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.56 us    (1.4%)
   patch tree reduce : 1421.00 ns (0.4%)
   gen split merge   : 641.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 968.00 ns  (0.3%)
   LB compute        : 299.23 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.36 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.7265112870499275e-18,-5.760138459959263e-17,9.16551990554071e-18)
    sum a = (2.995004147032104e-17,1.1690648449302898e-16,4.427317887301108e-17)
    sum e = 2.592001339007305
    sum de = 7.047314121155779e-19
Info: CFL hydro = 0.011144070828097938 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011144070828097938 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9391e+04 |  512 |      1 | 2.640e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.8601877989513 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.100177062981247, dt = 0.011144070828097938 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.92 us    (1.4%)
   patch tree reduce : 1302.00 ns (0.5%)
   gen split merge   : 667.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 997.00 ns  (0.3%)
   LB compute        : 274.16 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.368752317713721e-18,-5.5162905493455484e-17,9.705615217764363e-18)
    sum a = (-3.888832615303594e-17,-1.422690090735479e-16,-9.123951594247614e-17)
    sum e = 2.5920013423280923
    sum de = -8.402566836762659e-19
Info: CFL hydro = 0.011148208009473871 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011148208009473871 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9258e+04 |  512 |      1 | 2.659e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.0055891932536 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.111321133809346, dt = 0.011148208009473871 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.49 us    (1.5%)
   patch tree reduce : 1333.00 ns (0.4%)
   gen split merge   : 670.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1037.00 ns (0.3%)
   LB compute        : 284.04 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (64.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.6281338136888725e-18,-5.866693849471138e-17,7.821868153179424e-18)
    sum a = (6.030259299717733e-17,-1.3313568997253e-17,-1.7785382541712913e-16)
    sum e = 2.59200134568795
    sum de = 1.3688052427629493e-18
Info: CFL hydro = 0.011137557620960295 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137557620960295 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8948e+04 |  512 |      1 | 2.702e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1485.2470731916305 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.12246934181882, dt = 0.011137557620960295 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1865.00 ns (0.6%)
   gen split merge   : 810.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 997.00 ns  (0.3%)
   LB compute        : 293.41 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1991.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.6790509794790725e-18,-5.814001623888342e-17,5.342406204922323e-18)
    sum a = (8.859904997160495e-17,-3.752857399841325e-17,-4.680240570098526e-17)
    sum e = 2.5920013485786813
    sum de = -1.4907779871675686e-19
Info: CFL hydro = 0.011126030536554575 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011126030536554575 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9352e+04 |  512 |      1 | 2.646e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1515.4897382261404 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.13360689943978, dt = 0.011126030536554575 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.4%)
   patch tree reduce : 1167.00 ns (0.4%)
   gen split merge   : 655.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1295.00 ns (0.4%)
   LB compute        : 305.92 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.806079137777754e-18,-5.850007978036586e-17,5.6731962877476506e-18)
    sum a = (6.249737055999405e-17,1.1869802016284404e-16,-3.6451310719831654e-17)
    sum e = 2.5920013509673248
    sum de = -3.9979955110402976e-19
Info: CFL hydro = 0.011115461724353364 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011115461724353364 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8771e+04 |  512 |      1 | 2.728e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1468.4209463144605 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.144732929976334, dt = 0.011115461724353364 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.5%)
   patch tree reduce : 1361.00 ns (0.5%)
   gen split merge   : 744.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 962.00 ns  (0.3%)
   LB compute        : 278.25 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.51 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1922.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.400330348517059e-18,-5.64070274863826e-17,5.239949099622443e-18)
    sum a = (3.567556406541827e-17,-1.3172470926525736e-16,-1.5233907885159325e-16)
    sum e = 2.5920013526722068
    sum de = 1.3552527156068805e-20
Info: CFL hydro = 0.011105994929856394 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011105994929856394 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9396e+04 |  512 |      1 | 2.640e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1515.8683468316094 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.155848391700687, dt = 0.011105994929856394 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 1323.00 ns (0.4%)
   gen split merge   : 630.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 280.98 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.50 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.520351529011204e-18,-5.926118970545069e-17,2.934664230375139e-18)
    sum a = (-3.861461931459198e-17,1.4689421554137104e-16,-1.0402616268390119e-16)
    sum e = 2.592001353523153
    sum de = -3.2864878353466853e-19
Info: CFL hydro = 0.011097761387311536 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011097761387311536 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9323e+04 |  512 |      1 | 2.650e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1508.893410388883 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 13.166954386630543, dt = 0.011097761387311536 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.78 us    (1.6%)
   patch tree reduce : 1273.00 ns (0.4%)
   gen split merge   : 825.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 967.00 ns  (0.3%)
   LB compute        : 286.68 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.50 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1901.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.6333657317008135e-18,-5.603818190730303e-17,2.158917575961761e-18)
    sum a = (1.2757373282767936e-17,-8.310149443579995e-17,-2.5315687046667535e-17)
    sum e = 2.5920013534124866
    sum de = -1.8380614955418317e-18
Info: CFL hydro = 0.011090876542348155 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011090876542348155 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9302e+04 |  512 |      1 | 2.653e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1506.1780646631912 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.178052148017855, dt = 0.011090876542348155 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1602.00 ns (0.5%)
   gen split merge   : 771.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 968.00 ns  (0.3%)
   LB compute        : 281.45 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1909.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.116377799543106e-18,-5.826003741937758e-17,2.2306375496716766e-18)
    sum a = (-4.415315769251693e-17,6.062533287887195e-17,2.6638847377968843e-17)
    sum e = 2.5920013523033925
    sum de = 1.4399560103323106e-19
Info: CFL hydro = 0.011085439393077844 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011085439393077844 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9596e+04 |  512 |      1 | 2.613e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.1178620063454 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.189143024560202, dt = 0.011085439393077844 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1617.00 ns (0.6%)
   gen split merge   : 744.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 952.00 ns  (0.3%)
   LB compute        : 272.69 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1968.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.270374844352666e-18,-5.649192051648822e-17,2.731213692708234e-18)
    sum a = (4.4779609707779056e-17,8.360499792470222e-17,5.675538164440219e-17)
    sum e = 2.5920013502335815
    sum de = 7.310423730396646e-19
Info: CFL hydro = 0.011081531948040891 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011081531948040891 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9464e+04 |  512 |      1 | 2.631e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1517.0890157954932 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.20022846395328, dt = 0.011081531948040891 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 2.21 us    (0.7%)
   gen split merge   : 777.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 971.00 ns  (0.3%)
   LB compute        : 282.54 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.251035709365806e-18,-5.573959262900052e-17,3.489396271927347e-18)
    sum a = (3.9926070262430445e-17,-1.2200884833696303e-16,4.908573547623973e-17)
    sum e = 2.5920013473193153
    sum de = 1.8965067689023785e-18
Info: CFL hydro = 0.011079216670054563 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011079216670054563 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9422e+04 |  512 |      1 | 2.636e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1513.2812973146915 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.21130999590132, dt = 0.011079216670054563 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.94 us    (1.3%)
   patch tree reduce : 1525.00 ns (0.5%)
   gen split merge   : 648.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 792.00 ns  (0.3%)
   LB compute        : 296.88 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1991.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.748684506536651e-18,-5.835663983294603e-17,3.922643460052555e-18)
    sum a = (7.540550215484609e-17,1.1993336011817401e-17,1.7669459645430764e-17)
    sum e = 2.5920013437433895
    sum de = -1.3908280993915612e-18
Info: CFL hydro = 0.011078534466737299 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011078534466737299 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9750e+04 |  512 |      1 | 2.592e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1538.5326338597943 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.222389212571375, dt = 0.011078534466737299 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.5%)
   patch tree reduce : 1520.00 ns (0.5%)
   gen split merge   : 636.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 984.00 ns  (0.3%)
   LB compute        : 277.35 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.779110251266875e-18,-5.75135642236213e-17,3.864096542738338e-18)
    sum a = (-1.397924744711565e-16,-7.83182112912284e-17,5.794973875761222e-17)
    sum e = 2.592001339743548
    sum de = -2.337810934421869e-19
Info: CFL hydro = 0.011079505598861769 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011079505598861769 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9544e+04 |  512 |      1 | 2.620e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1522.4255789824292 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.233467747038112, dt = 0.011079505598861769 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.3%)
   patch tree reduce : 1228.00 ns (0.4%)
   gen split merge   : 768.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 949.00 ns  (0.3%)
   LB compute        : 292.28 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.51 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.778580738913242e-18,-5.873134010375703e-17,4.78913783630297e-18)
    sum a = (-3.4727104004927954e-17,1.5454922498020495e-16,9.601694439531627e-19)
    sum e = 2.5920013356029306
    sum de = 5.590417451878382e-19
Info: CFL hydro = 0.011082128529991629 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011082128529991629 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8858e+04 |  512 |      1 | 2.715e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1469.1289286266206 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.244547252636973, dt = 0.011082128529991629 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.59 us    (1.6%)
   patch tree reduce : 1711.00 ns (0.6%)
   gen split merge   : 631.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 997.00 ns  (0.3%)
   LB compute        : 277.76 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.1562083555899426e-18,-5.577472077938906e-17,4.537386091851836e-18)
    sum a = (1.6966896637660155e-17,5.486870723395154e-17,8.032637055510605e-18)
    sum e = 2.5920013316263915
    sum de = 2.0396553369883552e-18
Info: CFL hydro = 0.011086379386442736 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011086379386442736 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9253e+04 |  512 |      1 | 2.659e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1500.1863294090433 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.255629381166965, dt = 0.011086379386442736 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.5%)
   patch tree reduce : 1397.00 ns (0.5%)
   gen split merge   : 839.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 958.00 ns  (0.3%)
   LB compute        : 277.10 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1953.00 ns (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.466507017355294e-18,-5.578350281698618e-17,4.5900783174346314e-18)
    sum a = (6.131618650317972e-17,1.2175856026544474e-16,3.759883029919031e-17)
    sum e = 2.5920013281193253
    sum de = 8.334804200982315e-19
Info: CFL hydro = 0.011092212100398704 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011092212100398704 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9268e+04 |  512 |      1 | 2.657e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1501.927218059459 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 13.266715760553408, dt = 0.011092212100398704 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 2.25 us    (0.7%)
   gen split merge   : 801.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1037.00 ns (0.3%)
   LB compute        : 284.29 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1950.00 ns (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.417894423711323e-18,-5.4024167951693954e-17,5.1170005732625865e-18)
    sum a = (-2.3525615049785342e-17,-1.6173585908052514e-17,-6.857014955841123e-17)
    sum e = 2.592001325364205
    sum de = 1.0977546996415732e-18
Info: CFL hydro = 0.01109949106433872 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01109949106433872 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9244e+04 |  512 |      1 | 2.661e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1500.8806410326501 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.277807972653807, dt = 0.01109949106433872 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.56 us    (1.5%)
   patch tree reduce : 1251.00 ns (0.4%)
   gen split merge   : 669.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 965.00 ns  (0.3%)
   LB compute        : 284.55 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1794.00 ns (64.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.770950987389224e-18,-5.491700844073577e-17,3.86995123446976e-18)
    sum a = (-3.045757005978866e-17,-5.107925801078883e-17,3.901566569819437e-17)
    sum e = 2.592001323603101
    sum de = 1.3010426069826053e-18
Info: CFL hydro = 0.011101507844346395 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011101507844346395 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8974e+04 |  512 |      1 | 2.698e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1480.8044454193994 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.288907463718147, dt = 0.011101507844346395 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.6%)
   patch tree reduce : 1351.00 ns (0.5%)
   gen split merge   : 742.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 943.00 ns  (0.3%)
   LB compute        : 275.14 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.3625862391225585e-18,-5.583326769670327e-17,4.838902716020055e-18)
    sum a = (2.3104077245122978e-17,1.2379160196918094e-16,-3.6228832434037626e-17)
    sum e = 2.5920013229376
    sum de = -4.1335207826009857e-19
Info: CFL hydro = 0.011104975154594902 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011104975154594902 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9395e+04 |  512 |      1 | 2.640e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1513.8984632436861 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.300008971562493, dt = 0.011104975154594902 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1241.00 ns (0.4%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1343.00 ns (0.4%)
   LB compute        : 283.59 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1940.00 ns (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.06368557396031e-18,-5.320451110929492e-17,4.250506197012172e-18)
    sum a = (-2.299239900034611e-16,-1.3536047283047026e-16,3.997583514214753e-17)
    sum e = 2.592001323553619
    sum de = -8.199278929421627e-19
Info: CFL hydro = 0.011107304555295223 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011107304555295223 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9066e+04 |  512 |      1 | 2.685e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1488.6868245649011 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.311113946717088, dt = 0.011107304555295223 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.6%)
   patch tree reduce : 2.19 us    (0.8%)
   gen split merge   : 960.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1073.00 ns (0.4%)
   LB compute        : 273.66 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.161533534967731e-18,-5.632213445627699e-17,5.02625285142555e-18)
    sum a = (2.82035137431913e-17,-1.4291302516400427e-16,-1.1066538310733342e-16)
    sum e = 2.59200132543609
    sum de = 6.369687763352339e-19
Info: CFL hydro = 0.011109619644218666 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011109619644218666 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9224e+04 |  512 |      1 | 2.663e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1501.3285077763855 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.322221251272383, dt = 0.011109619644218666 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.5%)
   patch tree reduce : 1445.00 ns (0.5%)
   gen split merge   : 683.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 912.00 ns  (0.3%)
   LB compute        : 294.11 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.36 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.46 us    (70.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.8491484265500425e-18,-5.794973875761222e-17,3.029802971010742e-18)
    sum a = (1.4247392328414764e-16,5.467111138801606e-17,-1.2842851782046695e-16)
    sum e = 2.5920013285228376
    sum de = 1.1519648082658485e-18
Info: CFL hydro = 0.011112688001560652 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011112688001560652 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8722e+04 |  512 |      1 | 2.735e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1462.4944406482937 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.333330870916601, dt = 0.011112688001560652 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.5%)
   patch tree reduce : 1541.00 ns (0.5%)
   gen split merge   : 714.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 968.00 ns  (0.3%)
   LB compute        : 277.61 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1841.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.135405547670226e-18,-5.633384383973982e-17,1.610040226140974e-18)
    sum a = (6.180386402849548e-17,-6.08009736308146e-17,-6.006913716438688e-18)
    sum e = 2.5920013326619764
    sum de = 6.911788849595091e-19
Info: CFL hydro = 0.011116461576164784 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011116461576164784 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9464e+04 |  512 |      1 | 2.630e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1520.8537745643703 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.344443558918162, dt = 0.011116461576164784 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.5%)
   patch tree reduce : 1235.00 ns (0.4%)
   gen split merge   : 808.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1160.00 ns (0.4%)
   LB compute        : 277.31 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1972.00 ns (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.31397364547859e-18,-5.754576502814412e-17,2.1720906323574595e-18)
    sum a = (1.3755964141208554e-17,4.680240570098526e-17,-2.1744325090500284e-17)
    sum e = 2.5920013376173388
    sum de = 6.572975670693371e-19
Info: CFL hydro = 0.011120886222289012 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011120886222289012 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9569e+04 |  512 |      1 | 2.616e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.5780902507174 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.355560020494327, dt = 0.011120886222289012 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1227.00 ns (0.4%)
   gen split merge   : 757.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 270.73 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.286163859754336e-18,-5.640410014051689e-17,1.7446981359636736e-18)
    sum a = (-3.52379258584945e-18,8.11987196230879e-17,1.592476150946709e-17)
    sum e = 2.592001343091496
    sum de = 5.488773498207866e-19
Info: CFL hydro = 0.011125902072626325 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011125902072626325 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9754e+04 |  512 |      1 | 2.592e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1544.64309443226 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 13.366680906716615, dt = 0.011125902072626325 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.0%)
   patch tree reduce : 1554.00 ns (0.4%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 958.00 ns  (0.2%)
   LB compute        : 406.71 us  (96.2%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.01245702131037e-18,-5.508972184681271e-17,2.265765700060207e-18)
    sum a = (1.734349968328386e-16,-1.438614852244946e-16,-5.470623953840459e-17)
    sum e = 2.592001348746669
    sum de = -2.371692252312041e-19
Info: CFL hydro = 0.011119066373265974 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011119066373265974 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9370e+04 |  512 |      1 | 2.643e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1515.2901933775256 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.377806808789241, dt = 0.011119066373265974 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.91 us    (1.4%)
   patch tree reduce : 1269.00 ns (0.4%)
   gen split merge   : 641.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 876.00 ns  (0.3%)
   LB compute        : 269.67 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.59 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.9178477930284e-18,-5.826296476524328e-17,1.2646134139870923e-18)
    sum a = (-1.5771441769750483e-16,4.2036686631607975e-17,2.6305129949277804e-17)
    sum e = 2.592001354036281
    sum de = -1.3688052427629493e-18
Info: CFL hydro = 0.011111951366790608 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011111951366790608 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9409e+04 |  512 |      1 | 2.638e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1517.3748720681176 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.388925875162508, dt = 0.011111951366790608 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.82 us    (1.6%)
   patch tree reduce : 1385.00 ns (0.5%)
   gen split merge   : 744.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1106.00 ns (0.4%)
   LB compute        : 285.86 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1844.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.393323370712522e-18,-5.664706984737089e-17,2.0842702563861337e-18)
    sum a = (1.0580745264318624e-16,-5.148030439439122e-17,1.6761982427060396e-17)
    sum e = 2.592001358771634
    sum de = -2.2497195079074217e-18
Info: CFL hydro = 0.011105427107624763 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011105427107624763 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9817e+04 |  512 |      1 | 2.584e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1548.3088837895566 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.4000378265293, dt = 0.011105427107624763 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.90 us    (1.4%)
   patch tree reduce : 1312.00 ns (0.5%)
   gen split merge   : 653.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 771.00 ns  (0.3%)
   LB compute        : 270.42 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.70 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.93133223628384e-18,-5.772433312595249e-17,2.142817173700351e-18)
    sum a = (-4.0109029379037374e-17,-1.7720980932667274e-16,-1.410102503512922e-16)
    sum e = 2.5920013626721583
    sum de = -6.166399856011306e-19
Info: CFL hydro = 0.01109958429160163 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01109958429160163 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9726e+04 |  512 |      1 | 2.596e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1540.2748620093146 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.411143253636924, dt = 0.01109958429160163 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.3%)
   patch tree reduce : 1370.00 ns (0.4%)
   gen split merge   : 671.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 925.00 ns  (0.3%)
   LB compute        : 290.37 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.835041209575122e-18,-6.047896558558641e-17,-2.693158196453993e-19)
    sum a = (2.0459220255453215e-17,6.949519085197586e-18,-2.0327489691496225e-17)
    sum e = 2.5920013655003653
    sum de = -1.3552527156068805e-20
Info: CFL hydro = 0.01109450634105164 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01109450634105164 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9510e+04 |  512 |      1 | 2.624e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1522.6202337654772 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.422242837928525, dt = 0.01109450634105164 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.69 us    (1.3%)
   patch tree reduce : 890.00 ns  (0.3%)
   gen split merge   : 674.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1511.00 ns (0.5%)
   LB compute        : 270.21 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.60 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1855.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.52443116095003e-18,-5.910604037456802e-17,1.5222198501696481e-19)
    sum a = (-5.621748184157783e-17,-7.370178686100237e-17,3.9284981517839765e-17)
    sum e = 2.5920013671009507
    sum de = 1.6889836968250749e-18
Info: CFL hydro = 0.01109026756366386 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01109026756366386 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9799e+04 |  512 |      1 | 2.586e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1544.4849329175972 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.433337344269576, dt = 0.01109026756366386 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.4%)
   patch tree reduce : 1082.00 ns (0.4%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 725.00 ns  (0.3%)
   LB compute        : 271.56 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.262745092828648e-18,-6.060191411194626e-17,1.0245710529988016e-18)
    sum a = (4.521285689590427e-18,1.3387630847655484e-16,8.735492797867783e-17)
    sum e = 2.592001367403425
    sum de = 9.342773408214933e-19
Info: CFL hydro = 0.011086933078929629 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011086933078929629 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9636e+04 |  512 |      1 | 2.607e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.204567591838 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 13.44442761183324, dt = 0.011086933078929629 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.5%)
   patch tree reduce : 1138.00 ns (0.4%)
   gen split merge   : 646.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1309.00 ns (0.4%)
   LB compute        : 275.44 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.807231423850869e-18,-5.804634117118069e-17,2.1545265571631944e-18)
    sum a = (-1.5001037521542026e-16,-1.2944723418173432e-17,-2.867042540877218e-17)
    sum e = 2.59200136643446
    sum de = -2.1387581918171084e-19
Info: CFL hydro = 0.011083910791697384 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011083910791697384 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9386e+04 |  512 |      1 | 2.641e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1511.2395393096915 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.45551454491217, dt = 0.011083910791697384 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.3%)
   patch tree reduce : 1330.00 ns (0.4%)
   gen split merge   : 647.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1032.00 ns (0.3%)
   LB compute        : 291.14 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1958.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.1872568740396475e-18,-5.888941678050541e-17,1.0655538951187537e-18)
    sum a = (-9.646629198570289e-17,2.8787153325167405e-17,1.0891190293377263e-17)
    sum e = 2.5920013642975777
    sum de = -1.5924219408380846e-19
Info: CFL hydro = 0.011081561986465841 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011081561986465841 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9655e+04 |  512 |      1 | 2.605e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.780538767502 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 13.466598455703867, dt = 0.011081561986465841 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1457.00 ns (0.5%)
   gen split merge   : 662.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 902.00 ns  (0.3%)
   LB compute        : 279.57 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.34 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1908.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.385164106834871e-18,-5.827174680284042e-17,1.4695276245868527e-18)
    sum a = (2.1240821601598015e-17,3.160216229328161e-17,-3.238669098529212e-17)
    sum e = 2.5920013611970347
    sum de = 1.0418505251227894e-18
Info: CFL hydro = 0.011080297960379897 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011080297960379897 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9803e+04 |  512 |      1 | 2.585e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1543.030498570845 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 13.477680017690332, dt = 0.011080297960379897 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.87 us    (1.3%)
   patch tree reduce : 1429.00 ns (0.5%)
   gen split merge   : 660.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 961.00 ns  (0.3%)
   LB compute        : 275.55 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.362897625982299e-18,-5.8134161547152e-17,9.54314752221741e-19)
    sum a = (3.975482052928636e-17,4.575441588106077e-17,8.119286493135646e-17)
    sum e = 2.592001357405772
    sum de = -1.3823577699190182e-18
Info: CFL hydro = 0.011080149245033212 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011080149245033212 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9459e+04 |  512 |      1 | 2.631e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1516.0523290555248 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.488760315650712, dt = 0.011080149245033212 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.5%)
   patch tree reduce : 1469.00 ns (0.5%)
   gen split merge   : 649.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 972.00 ns  (0.3%)
   LB compute        : 271.08 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.003986370572978e-18,-5.747843607323277e-17,2.160381248894616e-18)
    sum a = (-1.0745481652911503e-16,-2.411547524172608e-17,-8.518869203805179e-17)
    sum e = 2.5920013532384036
    sum de = -4.980553729855286e-19
Info: CFL hydro = 0.011081130416873482 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011081130416873482 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9552e+04 |  512 |      1 | 2.619e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.2289392079742 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.499840464895746, dt = 0.00015953510425426032 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.85 us    (1.5%)
   patch tree reduce : 1227.00 ns (0.4%)
   gen split merge   : 785.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 893.00 ns  (0.3%)
   LB compute        : 311.53 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.48 us    (71.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.032107543156971e-18,-5.781800819365524e-17,1.4461088576611657e-18)
    sum a = (-2.4350394747449377e-17,6.305502994741197e-18,4.6331103016605813e-17)
    sum e = 2.592001270237282
    sum de = 1.8973538018496328e-18
Info: CFL hydro = 0.011081710116860944 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011081710116860944 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9747e+04 |  512 |      1 | 2.593e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 22.151066161163847 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 1570                                                    [SPH][rank=0]
Info: time since start : 1791.4756248370002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14988838383111827 max=0.15010646807973974 delta=0.00021808424862146403
Number of particle pairs: 130816
Distance min=0.131542 max=1.980027 mean=0.801147
---------------- t = 13.5, dt = 0.011081710116860944 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.16 us    (1.5%)
   patch tree reduce : 1234.00 ns (0.2%)
   gen split merge   : 753.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 878.00 ns  (0.1%)
   LB compute        : 599.09 us  (95.9%)
   LB move op cnt    : 0
   LB apply          : 5.93 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.56 us    (81.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.783283144571549e-18,-5.775946127634101e-17,1.926193579637747e-18)
    sum a = (1.8341468480728012e-17,2.108274492484963e-17,-7.897979145687906e-18)
    sum e = 2.5920013502754014
    sum de = -4.946672411965114e-19
Info: CFL hydro = 0.011083278477028025 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011083278477028025 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5828e+04 |  512 |      1 | 3.235e-02 | 0.1% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1233.2992973461198 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.51108171011686, dt = 0.011083278477028025 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.91 us    (1.3%)
   patch tree reduce : 1566.00 ns (0.5%)
   gen split merge   : 645.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 686.00 ns  (0.2%)
   LB compute        : 297.06 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.1638381071139605e-18,-5.750770953188988e-17,1.5339292336324916e-18)
    sum a = (1.1597279409310039e-16,-5.0935818063369e-17,-7.762735766692064e-17)
    sum e = 2.5920013458128586
    sum de = -1.4433441421213278e-18
Info: CFL hydro = 0.011086511867855363 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011086511867855363 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8984e+04 |  512 |      1 | 2.697e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1479.3818391781213 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.522164988593888, dt = 0.011086511867855363 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 2.25 us    (0.8%)
   gen split merge   : 765.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 843.00 ns  (0.3%)
   LB compute        : 282.83 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1970.00 ns (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.010993348377515e-18,-5.830102026149752e-17,3.9811903773667724e-19)
    sum a = (-4.6590539043954434e-18,-1.0308941200687371e-16,1.3638504388346907e-16)
    sum e = 2.592001342560317
    sum de = -5.89534931288993e-19
Info: CFL hydro = 0.011079299193014494 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011079299193014494 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9093e+04 |  512 |      1 | 2.682e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1488.3180661364838 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.533251500461743, dt = 0.011079299193014494 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.4%)
   patch tree reduce : 1455.00 ns (0.5%)
   gen split merge   : 754.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 917.00 ns  (0.3%)
   LB compute        : 299.28 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1882.00 ns (64.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.504562513609535e-18,-5.966516343491878e-17,3.0912772341906703e-18)
    sum a = (1.2790671841990398e-16,-1.1709383462843449e-19,1.7360331922011697e-16)
    sum e = 2.5920013400944013
    sum de = -2.168404344971009e-19
Info: CFL hydro = 0.011072765844985073 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011072765844985073 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8987e+04 |  512 |      1 | 2.697e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1479.117714513714 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 13.544330799654757, dt = 0.011072765844985073 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.4%)
   patch tree reduce : 1205.00 ns (0.4%)
   gen split merge   : 651.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 893.00 ns  (0.3%)
   LB compute        : 275.83 us  (91.2%)
   LB move op cnt    : 0
   LB apply          : 14.07 us   (4.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1967.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.582978078264247e-18,-5.901821999859669e-17,5.269222558279552e-18)
    sum a = (1.3060426763515654e-16,2.1135437150432423e-17,-1.5363296572423745e-16)
    sum e = 2.592001338752424
    sum de = 3.6591823321385775e-19
Info: CFL hydro = 0.011067421125884378 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011067421125884378 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8852e+04 |  512 |      1 | 2.716e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1467.7088621678529 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.555403565499741, dt = 0.011067421125884378 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.5%)
   patch tree reduce : 1135.00 ns (0.4%)
   gen split merge   : 733.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 893.00 ns  (0.3%)
   LB compute        : 292.83 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1935.00 ns (64.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.876864950908448e-18,-5.871670337442847e-17,1.5397839253639134e-18)
    sum a = (8.689240733189552e-17,3.1029866176535136e-17,3.908592199897143e-17)
    sum e = 2.592001338655033
    sum de = -1.4772254600114998e-18
Info: CFL hydro = 0.011063328896039814 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011063328896039814 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8797e+04 |  512 |      1 | 2.724e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1462.7586280605883 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.566470986625626, dt = 0.011063328896039814 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.84 us    (1.2%)
   patch tree reduce : 1448.00 ns (0.5%)
   gen split merge   : 656.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 844.00 ns  (0.3%)
   LB compute        : 296.27 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0509171657901994e-17,-5.801121302079215e-17,3.179097610161996e-18)
    sum a = (1.0163744845748112e-16,-3.467148443347945e-17,-7.361689383089675e-17)
    sum e = 2.5920013398261696
    sum de = 1.7618285302889447e-19
Info: CFL hydro = 0.01106053309112781 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01106053309112781 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9153e+04 |  512 |      1 | 2.673e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1489.9109638959926 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.577534315521666, dt = 0.01106053309112781 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.49 us    (1.1%)
   patch tree reduce : 1388.00 ns (0.4%)
   gen split merge   : 654.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 802.00 ns  (0.2%)
   LB compute        : 317.44 us  (95.6%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1922.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2078229041923017e-17,-5.908262160764233e-17,1.5339292336324916e-18)
    sum a = (-3.8241382716713844e-17,-2.8676280100503606e-17,-2.6193890806380793e-17)
    sum e = 2.592001342197216
    sum de = 6.776263578034403e-20
Info: CFL hydro = 0.011059058415174544 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011059058415174544 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9483e+04 |  512 |      1 | 2.628e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1515.1812438332233 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.588594848612793, dt = 0.011059058415174544 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.96 us    (1.4%)
   patch tree reduce : 1545.00 ns (0.5%)
   gen split merge   : 665.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 842.00 ns  (0.3%)
   LB compute        : 270.03 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (63.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0816542973801635e-17,-5.952465083336467e-17,1.504655774975383e-18)
    sum a = (-1.920251067530354e-16,-7.547868580148887e-17,-1.3605132645477803e-16)
    sum e = 2.592001345609891
    sum de = 1.0367683274392636e-18
Info: CFL hydro = 0.011058909608048634 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011058909608048634 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9160e+04 |  512 |      1 | 2.672e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1489.8334902948952 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.599653907027967, dt = 0.011058909608048634 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.96 us    (1.4%)
   patch tree reduce : 1235.00 ns (0.4%)
   gen split merge   : 634.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 637.00 ns  (0.2%)
   LB compute        : 273.57 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.567189062862578e-18,-6.073071733003754e-17,-4.683753385137379e-19)
    sum a = (-1.444791552021596e-17,3.5268662990084464e-17,6.053751250290063e-17)
    sum e = 2.592001349830506
    sum de = -5.082197683525802e-19
Info: CFL hydro = 0.011060071518441131 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011060071518441131 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9589e+04 |  512 |      1 | 2.614e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.2273208962079 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.610712816636015, dt = 0.011060071518441131 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.4%)
   patch tree reduce : 1185.00 ns (0.4%)
   gen split merge   : 590.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 741.00 ns  (0.2%)
   LB compute        : 287.96 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1899.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.666407435437006e-18,-5.935486477315344e-17,1.1914297673443207e-18)
    sum a = (1.2290022515307197e-16,4.61935177609174e-17,4.6146680227066027e-17)
    sum e = 2.5920013545662433
    sum de = 6.911788849595091e-19
Info: CFL hydro = 0.011062509656352379 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011062509656352379 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8944e+04 |  512 |      1 | 2.703e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1473.1840852299738 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.621772888154457, dt = 0.011062509656352379 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.5%)
   patch tree reduce : 1571.00 ns (0.5%)
   gen split merge   : 641.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 878.00 ns  (0.3%)
   LB compute        : 270.87 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0474043507513464e-17,-5.876939560001127e-17,1.612967572006685e-18)
    sum a = (2.1750472516818275e-16,1.0163744845748112e-16,-2.750534175421926e-17)
    sum e = 2.5920013594856424
    sum de = -1.3349239248727773e-18
Info: CFL hydro = 0.011066170722264798 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011066170722264798 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9367e+04 |  512 |      1 | 2.644e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1506.403153940899 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 13.632835397810808, dt = 0.011066170722264798 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 1545.00 ns (0.5%)
   gen split merge   : 727.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 958.00 ns  (0.3%)
   LB compute        : 275.66 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1816.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3632649696615485e-17,-5.762773071238403e-17,9.426053687588975e-19)
    sum a = (-5.995936169442273e-17,-2.9601321394068236e-17,5.21770127104304e-17)
    sum e = 2.592001364242959
    sum de = -3.1848438816761693e-19
Info: CFL hydro = 0.011070983381778539 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011070983381778539 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8451e+04 |  512 |      1 | 2.775e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1435.665918115203 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 13.643901568533073, dt = 0.011070983381778539 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.5%)
   patch tree reduce : 1768.00 ns (0.6%)
   gen split merge   : 771.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 959.00 ns  (0.3%)
   LB compute        : 270.06 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1852.00 ns (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.134346522962959e-17,-5.868742991577137e-17,1.9788858052205426e-18)
    sum a = (-3.947965001790954e-17,6.95888659196786e-17,1.002323224419399e-17)
    sum e = 2.592001368503617
    sum de = -1.07742590890747e-18
Info: CFL hydro = 0.011076859608322248 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011076859608322248 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9166e+04 |  512 |      1 | 2.671e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1491.9050852930186 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.65497255191485, dt = 0.011076859608322248 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.6%)
   patch tree reduce : 1247.00 ns (0.4%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 904.00 ns  (0.3%)
   LB compute        : 276.22 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0774096458748827e-17,-5.766285886277256e-17,1.932048271369169e-18)
    sum a = (1.803084049255277e-16,-9.811292403516525e-17,-1.6445829073563623e-17)
    sum e = 2.5920013719674015
    sum de = -2.0328790734103208e-20
Info: CFL hydro = 0.011083694902402479 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011083694902402479 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9584e+04 |  512 |      1 | 2.614e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1525.2551472241878 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.666049411523172, dt = 0.011083694902402479 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1129.00 ns (0.4%)
   gen split merge   : 948.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1189.00 ns (0.4%)
   LB compute        : 275.76 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1967.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4010277313292186e-17,-5.924948032198785e-17,1.484164353915407e-18)
    sum a = (-2.931663700862786e-17,-7.231715226652114e-17,4.758693439299577e-17)
    sum e = 2.5920013743905046
    sum de = 4.2690460541616737e-19
Info: CFL hydro = 0.011091370691506086 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011091370691506086 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9826e+04 |  512 |      1 | 2.582e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1545.1150013515994 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.677133106425575, dt = 0.011091370691506086 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.5%)
   patch tree reduce : 1603.00 ns (0.6%)
   gen split merge   : 973.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 854.00 ns  (0.3%)
   LB compute        : 272.16 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2609542316549537e-17,-6.036772644268939e-17,2.3448040384344003e-18)
    sum a = (-2.513126425712775e-17,-6.614630718160264e-17,9.794899266668544e-18)
    sum e = 2.59200137560429
    sum de = 1.0842021724855044e-19
Info: CFL hydro = 0.011099755720495366 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011099755720495366 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9923e+04 |  512 |      1 | 2.570e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1553.7156152711445 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.688224477117082, dt = 0.011099755720495366 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 1295.00 ns (0.4%)
   gen split merge   : 645.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1188.00 ns (0.4%)
   LB compute        : 284.10 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1896.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2473420733793983e-17,-6.07482814052318e-17,2.1955093992831465e-18)
    sum a = (-3.0793482997878983e-17,-2.91329460555545e-17,-1.2435365237539741e-17)
    sum e = 2.592001375531088
    sum de = 5.251604272976662e-20
Info: CFL hydro = 0.011108708090124026 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011108708090124026 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9247e+04 |  512 |      1 | 2.660e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1502.1436879342582 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.699324232837577, dt = 0.011108708090124026 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.08 us    (1.4%)
   patch tree reduce : 1252.00 ns (0.4%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 963.00 ns  (0.3%)
   LB compute        : 278.21 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1922.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2183613493088607e-17,-6.087708462332308e-17,2.0579241435947358e-18)
    sum a = (-1.4542322424385133e-17,5.1269535492060035e-17,5.2990814861098025e-17)
    sum e = 2.5920013741895374
    sum de = 1.4848487565367885e-18
Info: CFL hydro = 0.0111144441448372 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0111144441448372 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9173e+04 |  512 |      1 | 2.670e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1497.5809444195454 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.710432940927701, dt = 0.0111144441448372 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.99 us    (1.4%)
   patch tree reduce : 1443.00 ns (0.5%)
   gen split merge   : 794.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 842.00 ns  (0.3%)
   LB compute        : 278.44 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1909.00 ns (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.203870987273592e-17,-5.992862456283277e-17,2.8365981438738253e-18)
    sum a = (-8.25006566968628e-17,-4.537386091851836e-17,1.3140562856589488e-16)
    sum e = 2.592001371633495
    sum de = 7.028255879842557e-19
Info: CFL hydro = 0.011105686431205358 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011105686431205358 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9680e+04 |  512 |      1 | 2.602e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.9560751328354 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.721547385072538, dt = 0.011105686431205358 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.96 us    (1.3%)
   patch tree reduce : 1831.00 ns (0.6%)
   gen split merge   : 721.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 890.00 ns  (0.3%)
   LB compute        : 296.36 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.078287849634596e-17,-6.115810982643132e-17,4.6954627686002226e-18)
    sum a = (7.732437736981957e-17,-6.533250503093502e-17,8.486375664695789e-17)
    sum e = 2.5920013679018385
    sum de = -7.78423278526702e-19
Info: CFL hydro = 0.011096018779639732 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011096018779639732 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9404e+04 |  512 |      1 | 2.639e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1515.2244399691217 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.732653071503744, dt = 0.011096018779639732 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.4%)
   patch tree reduce : 1109.00 ns (0.4%)
   gen split merge   : 698.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 953.00 ns  (0.3%)
   LB compute        : 273.93 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1897.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2687116981990876e-17,-6.136887872876251e-17,5.544393069656372e-18)
    sum a = (1.34593508213654e-16,5.701957460878259e-17,-6.9868427449854e-17)
    sum e = 2.592001363511102
    sum de = -2.761327408049019e-19
Info: CFL hydro = 0.011087749056373773 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011087749056373773 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9206e+04 |  512 |      1 | 2.666e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1498.3960212203026 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.743749090283384, dt = 0.011087749056373773 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.5%)
   patch tree reduce : 1655.00 ns (0.6%)
   gen split merge   : 669.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 889.00 ns  (0.3%)
   LB compute        : 278.69 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4341067396117512e-17,-6.043212805173504e-17,3.7440753622441926e-18)
    sum a = (-1.3242727227302797e-16,2.480486519310099e-17,5.83610308517446e-17)
    sum e = 2.5920013588299224
    sum de = 2.0972535774016476e-18
Info: CFL hydro = 0.011080977270379698 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011080977270379698 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9599e+04 |  512 |      1 | 2.612e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.9881834768673 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.754836839339758, dt = 0.011080977270379698 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.4%)
   patch tree reduce : 1220.00 ns (0.4%)
   gen split merge   : 745.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 871.00 ns  (0.3%)
   LB compute        : 279.32 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1903.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1097568176909878e-17,-6.028576075844949e-17,5.1170005732625865e-18)
    sum a = (-1.5228638662601047e-16,-7.472928525986688e-17,1.7216379689065364e-16)
    sum e = 2.5920013542147773
    sum de = 1.6364676540953083e-18
Info: CFL hydro = 0.011075781322809694 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011075781322809694 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9481e+04 |  512 |      1 | 2.628e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1517.8241543547838 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.765917816610138, dt = 0.011075781322809694 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.4%)
   patch tree reduce : 1819.00 ns (0.6%)
   gen split merge   : 1025.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 987.00 ns  (0.3%)
   LB compute        : 278.27 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.765625808011436e-18,-6.172016023264782e-17,7.772103273462339e-18)
    sum a = (1.3692367552275985e-16,-2.594213906192966e-17,-4.3094922162062455e-17)
    sum e = 2.592001350020467
    sum de = -1.9651164376299768e-19
Info: CFL hydro = 0.011072216533918445 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011072216533918445 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9288e+04 |  512 |      1 | 2.655e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1502.044805247274 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 13.776993597932947, dt = 0.011072216533918445 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1623.00 ns (0.6%)
   gen split merge   : 702.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 935.00 ns  (0.3%)
   LB compute        : 276.04 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2678334944393743e-17,-6.171430554091639e-17,6.0976614382757255e-18)
    sum a = (-3.2991187906561417e-17,3.155678843236309e-17,2.1928747880040068e-17)
    sum e = 2.5920013465680114
    sum de = -1.7211709488207383e-18
Info: CFL hydro = 0.011070315468487295 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011070315468487295 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9356e+04 |  512 |      1 | 2.645e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1506.922054250598 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 13.788065814466865, dt = 0.011070315468487295 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 1358.00 ns (0.5%)
   gen split merge   : 1153.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 278.03 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1948.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1574725553020748e-17,-6.122836612720839e-17,6.703622032477874e-18)
    sum a = (2.959546670233681e-17,2.780978572425319e-17,-2.9127091363823074e-17)
    sum e = 2.592001344127104
    sum de = -7.589415207398531e-19
Info: CFL hydro = 0.011070088482283155 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011070088482283155 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9394e+04 |  512 |      1 | 2.640e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.593790862758 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 13.799136129935352, dt = 0.011070088482283155 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1274.00 ns (0.4%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 986.00 ns  (0.3%)
   LB compute        : 282.34 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1893.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1975771936623136e-17,-6.059605942021484e-17,6.208900581172738e-18)
    sum a = (-1.6201688428363335e-16,6.207144173653312e-17,-5.906798487831378e-17)
    sum e = 2.5920013428981528
    sum de = -7.657177843178875e-19
Info: CFL hydro = 0.011071524123126772 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011071524123126772 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8650e+04 |  512 |      1 | 2.745e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1451.6726771726935 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.810206218417635, dt = 0.011071524123126772 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.6%)
   patch tree reduce : 1359.00 ns (0.5%)
   gen split merge   : 1025.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 957.00 ns  (0.3%)
   LB compute        : 280.95 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1873.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.893276740029598e-18,-5.969443689357589e-17,5.283859287608106e-18)
    sum a = (-6.533835972266644e-17,-5.951879614163324e-17,-1.3050107869339023e-17)
    sum e = 2.5920013429992372
    sum de = 3.9302328752599536e-19
Info: CFL hydro = 0.011074589179159803 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011074589179159803 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9634e+04 |  512 |      1 | 2.608e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.4418490625021 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.821277742540762, dt = 0.011074589179159803 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.4%)
   patch tree reduce : 1243.00 ns (0.4%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 886.00 ns  (0.3%)
   LB compute        : 272.68 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.79374698059543e-18,-6.131033181144829e-17,5.380461701176564e-18)
    sum a = (-8.428999685727856e-17,-1.1099324584429304e-16,-2.384030473034926e-17)
    sum e = 2.592001344457534
    sum de = 9.690056916589196e-19
Info: CFL hydro = 0.011079229802349122 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011079229802349122 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0022e+04 |  512 |      1 | 2.557e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1559.0897598953877 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.832352331719921, dt = 0.011079229802349122 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.5%)
   patch tree reduce : 1702.00 ns (0.6%)
   gen split merge   : 683.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 867.00 ns  (0.3%)
   LB compute        : 274.36 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.71 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1902.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.070692551764846e-18,-6.27681500525723e-17,5.1404193401882735e-18)
    sum a = (-1.3842833129773525e-16,-2.880508331859488e-17,-1.5292454802473543e-16)
    sum e = 2.5920013472050263
    sum de = 9.351243737687476e-19
Info: CFL hydro = 0.011085372895465859 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011085372895465859 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9765e+04 |  512 |      1 | 2.590e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1539.704373366931 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 13.84343156152227, dt = 0.011085372895465859 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.6%)
   patch tree reduce : 1305.00 ns (0.5%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1209.00 ns (0.4%)
   LB compute        : 270.54 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (64.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.796144814107507e-18,-6.262178275928675e-17,2.710722271648258e-18)
    sum a = (7.210638336418995e-17,5.599427171931737e-17,-1.2277288560791355e-17)
    sum e = 2.5920013510845417
    sum de = -1.9109063290057016e-18
Info: CFL hydro = 0.011092926555584205 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011092926555584205 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9372e+04 |  512 |      1 | 2.643e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.9449578262597 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.854516934417735, dt = 0.011092926555584205 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.82 us    (1.3%)
   patch tree reduce : 1216.00 ns (0.4%)
   gen split merge   : 712.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 772.00 ns  (0.3%)
   LB compute        : 280.39 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.57 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1959.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.044346438973448e-18,-6.146255379646525e-17,3.3840118207617564e-18)
    sum a = (-9.27617357926458e-17,-2.0470344169742916e-16,1.4613310561628622e-17)
    sum e = 2.5920013558630814
    sum de = -2.236166980751353e-19
Info: CFL hydro = 0.011101781577205348 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011101781577205348 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9822e+04 |  512 |      1 | 2.583e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1546.0401516001511 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.865609860973318, dt = 0.011101781577205348 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.77 us    (1.3%)
   patch tree reduce : 1535.00 ns (0.5%)
   gen split merge   : 773.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 760.00 ns  (0.3%)
   LB compute        : 274.62 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.226464656367004e-18,-6.483485623376417e-17,3.621126835884336e-18)
    sum a = (-1.5195266919731943e-16,-1.8805269841326578e-17,1.031947964580393e-16)
    sum e = 2.5920013612444364
    sum de = -8.809142651444724e-19
Info: CFL hydro = 0.011111812976931866 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011111812976931866 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9687e+04 |  512 |      1 | 2.601e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.750283122305 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 13.876711642550523, dt = 0.011111812976931866 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 15.87 us   (5.2%)
   patch tree reduce : 1001.00 ns (0.3%)
   gen split merge   : 643.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 763.00 ns  (0.3%)
   LB compute        : 277.27 us  (91.1%)
   LB move op cnt    : 0
   LB apply          : 2.64 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.27685230980357e-18,-6.425524175235342e-17,5.316060092130925e-18)
    sum a = (2.001602009138459e-16,-1.0140326078822426e-16,1.967176421757699e-18)
    sum e = 2.59200136689033
    sum de = -3.3203691532368573e-19
Info: CFL hydro = 0.011122881774876319 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011122881774876319 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9740e+04 |  512 |      1 | 2.594e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.2524144153986 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.887823455527455, dt = 0.011122881774876319 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.67 us    (1.3%)
   patch tree reduce : 1126.00 ns (0.4%)
   gen split merge   : 634.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 826.00 ns  (0.3%)
   LB compute        : 272.76 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.474666281232945e-18,-6.571598733934315e-17,4.6632619640774034e-18)
    sum a = (-1.6792426824063788e-16,9.255096689031461e-17,1.662029888715999e-16)
    sum e = 2.5920013724444098
    sum de = -6.844026213814747e-19
Info: CFL hydro = 0.011134837004958776 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011134837004958776 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9438e+04 |  512 |      1 | 2.634e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1520.2260032585255 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.89894633730233, dt = 0.011134837004958776 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.63 us    (1.2%)
   patch tree reduce : 882.00 ns  (0.3%)
   gen split merge   : 630.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 792.00 ns  (0.3%)
   LB compute        : 284.34 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.78 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1994.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.578368933971788e-18,-6.397714389511089e-17,7.464731957562697e-18)
    sum a = (-8.800772610673135e-17,-4.135754239076306e-17,-6.333605515052021e-17)
    sum e = 2.592001377557651
    sum de = -5.963111948670274e-19
Info: CFL hydro = 0.011147518054097878 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011147518054097878 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0016e+04 |  512 |      1 | 2.558e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1567.1072186172994 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.910081174307289, dt = 0.011147518054097878 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.67 us    (1.2%)
   patch tree reduce : 1207.00 ns (0.4%)
   gen split merge   : 641.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 716.00 ns  (0.2%)
   LB compute        : 288.29 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.626981527615758e-18,-6.520662915870945e-17,5.462427385416468e-18)
    sum a = (1.040847096012154e-16,-1.903243188050574e-16,-2.780978572425319e-17)
    sum e = 2.592001381913662
    sum de = 4.811147140404426e-19
Info: CFL hydro = 0.011160757009214184 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011160757009214184 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0063e+04 |  512 |      1 | 2.552e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1572.5690803956606 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.921228692361387, dt = 0.011160757009214184 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1013.00 ns (0.3%)
   gen split merge   : 666.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 583.00 ns  (0.2%)
   LB compute        : 289.46 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.60 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.948366799124471e-18,-6.829497904703441e-17,5.403880468102251e-18)
    sum a = (1.0970521366338026e-16,-1.7362673798704264e-16,-6.22002449546244e-17)
    sum e = 2.5920013852543877
    sum de = 1.7618285302889447e-18
Info: CFL hydro = 0.01116199341829809 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01116199341829809 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9904e+04 |  512 |      1 | 2.572e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1561.9681435925418 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.932389449370602, dt = 0.01116199341829809 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.3%)
   patch tree reduce : 1453.00 ns (0.5%)
   gen split merge   : 740.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 902.00 ns  (0.3%)
   LB compute        : 288.16 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.177852062723033e-18,-7.030021096504635e-17,4.48469386626904e-18)
    sum a = (-1.1411965122887224e-16,-1.6669478297703933e-16,-6.590041012888292e-17)
    sum e = 2.592001387183438
    sum de = 1.5551524911588954e-18
Info: CFL hydro = 0.011156817817930683 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011156817817930683 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9137e+04 |  512 |      1 | 2.675e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1501.9407370071228 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.9435514427889, dt = 0.011156817817930683 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.90 us    (1.2%)
   patch tree reduce : 1392.00 ns (0.4%)
   gen split merge   : 666.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 824.00 ns  (0.3%)
   LB compute        : 297.13 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.6574072723459815e-18,-7.198343483783009e-17,3.729438632915638e-18)
    sum a = (-3.022191871759894e-17,3.266917986133322e-17,-5.331282290632622e-17)
    sum e = 2.592001387702706
    sum de = -5.996993266560446e-19
Info: CFL hydro = 0.011152756005801536 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011152756005801536 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9689e+04 |  512 |      1 | 2.600e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1544.5366177794529 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.95470826060683, dt = 0.011152756005801536 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.5%)
   patch tree reduce : 1230.00 ns (0.4%)
   gen split merge   : 745.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 846.00 ns  (0.3%)
   LB compute        : 274.18 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1966.00 ns (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.06138100181408e-18,-7.039974072448052e-17,3.2903367530590087e-18)
    sum a = (3.556139757665555e-17,1.034875310446104e-16,-1.083703439486161e-17)
    sum e = 2.5920013869559257
    sum de = 1.4247094172817332e-18
Info: CFL hydro = 0.011149887979744309 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011149887979744309 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9731e+04 |  512 |      1 | 2.595e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1547.2903779078383 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.965861016612632, dt = 0.011149887979744309 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.4%)
   patch tree reduce : 1436.00 ns (0.5%)
   gen split merge   : 698.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 837.00 ns  (0.3%)
   LB compute        : 273.10 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.6029399869705895e-18,-6.909121712250777e-17,3.4659775050016606e-18)
    sum a = (-4.941359821319935e-17,5.70246974640476e-17,-9.0876525055128e-17)
    sum e = 2.592001385069408
    sum de = -1.4230153513872246e-18
Info: CFL hydro = 0.011147855882894908 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011147855882894908 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9614e+04 |  512 |      1 | 2.610e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.7123814971544 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.977010904592376, dt = 0.011147855882894908 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.3%)
   patch tree reduce : 1575.00 ns (0.5%)
   gen split merge   : 678.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 835.00 ns  (0.3%)
   LB compute        : 299.13 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.478839174537619e-18,-6.85057479493656e-17,1.86764666232353e-18)
    sum a = (-2.7833204491178877e-17,1.820809128472156e-17,3.0725422206501207e-17)
    sum e = 2.592001382233618
    sum de = -1.3527910261039227e-18
Info: CFL hydro = 0.011146008772358284 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011146008772358284 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9053e+04 |  512 |      1 | 2.687e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1493.4228261307596 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.98815876047527, dt = 0.011146008772358284 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.88 us    (1.7%)
   patch tree reduce : 1137.00 ns (0.4%)
   gen split merge   : 690.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1015.00 ns (0.3%)
   LB compute        : 275.79 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (70.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.338326572983498e-18,-6.812812033268889e-17,2.8922177153223315e-18)
    sum a = (1.59013427425414e-17,-1.2279630437483924e-16,8.056055822436292e-17)
    sum e = 2.5920013787051435
    sum de = -4.2351647362715017e-19
Info: CFL hydro = 0.011145539718255625 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011145539718255625 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9442e+04 |  512 |      1 | 2.633e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.6855065590662 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 13.99930476924763, dt = 0.0006952307523704349 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.4%)
   patch tree reduce : 1487.00 ns (0.5%)
   gen split merge   : 789.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 943.00 ns  (0.3%)
   LB compute        : 292.47 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.78 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.45 us    (71.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.519822016657571e-18,-6.918781953607622e-17,3.2961914447904307e-18)
    sum a = (2.8102520310824273e-18,1.808397182001542e-16,-4.8312916167692066e-17)
    sum e = 2.5920012948752498
    sum de = -2.0074680849926918e-19
Info: CFL hydro = 0.011146245670787118 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011146245670787118 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9767e+04 |  512 |      1 | 2.590e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 96.62823816868051 (tsim/hr)                             [sph::Model][rank=0]
Info: iteration since start : 1616                                                    [SPH][rank=0]
Info: time since start : 1793.324837847 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14989658697546102 max=0.15012554248660095 delta=0.00022895551113993884
Number of particle pairs: 130816
Distance min=0.130187 max=1.976914 mean=0.800884
---------------- t = 14, dt = 0.011146245670787118 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.67 us    (1.5%)
   patch tree reduce : 1091.00 ns (0.2%)
   gen split merge   : 524.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 803.00 ns  (0.1%)
   LB compute        : 618.97 us  (96.0%)
   LB move op cnt    : 0
   LB apply          : 6.09 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.80 us    (77.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.830120678422922e-18,-6.729821777975986e-17,2.8395254897395363e-18)
    sum a = (1.0081779161508209e-16,-3.7130454960676575e-17,-3.618199490018625e-18)
    sum e = 2.5920013757183176
    sum de = -1.40438062654763e-18
Info: CFL hydro = 0.011146573451722045 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011146573451722045 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5539e+04 |  512 |      1 | 3.295e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1217.8211036396656 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.011146245670787, dt = 0.011146573451722045 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.5%)
   patch tree reduce : 975.00 ns  (0.3%)
   gen split merge   : 903.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1082.00 ns (0.4%)
   LB compute        : 278.54 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.5806735061180175e-18,-6.883361068632521e-17,2.6463206626026194e-18)
    sum a = (1.1484563300356853e-16,2.2915263436784627e-17,-3.26633251696018e-17)
    sum e = 2.592001371300988
    sum de = -6.742382260144231e-19
Info: CFL hydro = 0.011143337723221647 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011143337723221647 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9368e+04 |  512 |      1 | 2.644e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1517.9747648278644 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.022292819122509, dt = 0.011143337723221647 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.3%)
   patch tree reduce : 1000.00 ns (0.3%)
   gen split merge   : 665.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 880.00 ns  (0.3%)
   LB compute        : 283.42 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1880.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.728193085476676e-18,-6.845012837791709e-17,2.3594407677629548e-18)
    sum a = (7.378082519937657e-17,-6.460652325623872e-17,2.112372776696958e-17)
    sum e = 2.5920013676422275
    sum de = -1.3247595295057257e-18
Info: CFL hydro = 0.011137710886982908 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137710886982908 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9551e+04 |  512 |      1 | 2.619e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.8504094822072 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.033436156845731, dt = 0.011137710886982908 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.63 us    (1.2%)
   patch tree reduce : 840.00 ns  (0.3%)
   gen split merge   : 717.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 779.00 ns  (0.3%)
   LB compute        : 290.64 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1965.00 ns (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.319516950350269e-18,-6.913659098342628e-17,2.950764632636549e-18)
    sum a = (1.5613291909355452e-16,-4.639843197151716e-17,-4.1022361289139167e-17)
    sum e = 2.592001364597631
    sum de = 1.4840017235895342e-18
Info: CFL hydro = 0.011132674453466319 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011132674453466319 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7575e+04 |  512 |      1 | 2.913e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1376.348481649428 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.044573867732714, dt = 0.011132674453466319 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.91 us    (1.3%)
   patch tree reduce : 882.00 ns  (0.3%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1136.00 ns (0.4%)
   LB compute        : 281.97 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.61 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1966.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0649684259456116e-17,-6.995332047995962e-17,2.0725608729232902e-18)
    sum a = (-1.1789007270390784e-16,9.61867304555275e-17,6.409789691207146e-17)
    sum e = 2.5920013624380807
    sum de = -2.6664597179565375e-18
Info: CFL hydro = 0.011128332681734488 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011128332681734488 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9413e+04 |  512 |      1 | 2.637e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1519.5844446038968 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.05570654218618, dt = 0.011128332681734488 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.6%)
   patch tree reduce : 930.00 ns  (0.3%)
   gen split merge   : 733.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 687.00 ns  (0.2%)
   LB compute        : 280.57 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1857.00 ns (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.581825792191132e-18,-6.817934888533883e-17,3.372302437298913e-18)
    sum a = (3.214811229723669e-17,3.8900767372965216e-17,1.1129768981432697e-17)
    sum e = 2.5920013613390243
    sum de = -2.439454888092385e-19
Info: CFL hydro = 0.011124774177824417 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011124774177824417 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9746e+04 |  512 |      1 | 2.593e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1545.0142148583448 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.066834874867913, dt = 0.011124774177824417 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.08 us    (1.4%)
   patch tree reduce : 1617.00 ns (0.5%)
   gen split merge   : 761.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 906.00 ns  (0.3%)
   LB compute        : 280.60 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1948.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.022079958120876e-18,-6.795833427247766e-17,3.348883670373226e-18)
    sum a = (-3.437289515517694e-17,7.74575716067094e-17,4.099894252221348e-17)
    sum e = 2.5920013613907593
    sum de = -2.0328790734103208e-20
Info: CFL hydro = 0.011122071503207374 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011122071503207374 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9705e+04 |  512 |      1 | 2.598e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1541.3714235240031 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.077959649045738, dt = 0.011122071503207374 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.75 us    (1.2%)
   patch tree reduce : 1233.00 ns (0.4%)
   gen split merge   : 744.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 757.00 ns  (0.3%)
   LB compute        : 287.46 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1935.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.173149657064727e-18,-6.704646603530873e-17,3.858241851006916e-18)
    sum a = (2.9905765364102165e-17,1.5697014001114785e-16,6.188994629285904e-17)
    sum e = 2.5920013625910894
    sum de = 2.120970499924768e-18
Info: CFL hydro = 0.011120281642574578 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011120281642574578 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9626e+04 |  512 |      1 | 2.609e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1534.7825934722307 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.089081720548945, dt = 0.011120281642574578 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 1038.00 ns (0.3%)
   gen split merge   : 831.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 811.00 ns  (0.3%)
   LB compute        : 282.29 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1861.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.688362529429838e-18,-6.466067915475437e-17,4.560804858777523e-18)
    sum a = (-9.303690630402262e-17,1.0704132892558338e-16,1.2435950706712883e-16)
    sum e = 2.592001364849709
    sum de = 4.1335207826009857e-19
Info: CFL hydro = 0.011119445539138566 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011119445539138566 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9887e+04 |  512 |      1 | 2.575e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1554.9710976317228 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.10020200219152, dt = 0.011119445539138566 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.4%)
   patch tree reduce : 1157.00 ns (0.4%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 854.00 ns  (0.3%)
   LB compute        : 277.68 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1860.00 ns (64.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.136869220603081e-18,-6.367416359800981e-17,6.5221265888038e-18)
    sum a = (8.881567356566755e-17,9.252754812338892e-17,-5.2756627191841154e-17)
    sum e = 2.5920013679918514
    sum de = 3.9979955110402976e-19
Info: CFL hydro = 0.011118467101326085 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011118467101326085 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9555e+04 |  512 |      1 | 2.618e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.8621081436222 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.111321447730658, dt = 0.011118467101326085 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 17.62 us   (5.5%)
   patch tree reduce : 1074.00 ns (0.3%)
   gen split merge   : 988.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1034.00 ns (0.3%)
   LB compute        : 291.08 us  (90.6%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1882.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.226994168720637e-18,-6.265398356380958e-17,4.771573761108705e-18)
    sum a = (-4.251494176241849e-17,2.9015852220926066e-17,-4.917941054394248e-19)
    sum e = 2.59200137176515
    sum de = 3.2526065174565133e-19
Info: CFL hydro = 0.011116710790178473 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011116710790178473 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9490e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.6830418346156 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.122439914831984, dt = 0.011116710790178473 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.90 us    (1.3%)
   patch tree reduce : 1028.00 ns (0.3%)
   gen split merge   : 825.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 279.21 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1981.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.009218288584918e-18,-6.31165042105919e-17,5.1638381071139605e-18)
    sum a = (4.176663897549615e-17,-1.4194114633658827e-16,1.0120420126935592e-16)
    sum e = 2.5920013758666305
    sum de = -1.0164395367051604e-19
Info: CFL hydro = 0.01111587305990721 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01111587305990721 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9286e+04 |  512 |      1 | 2.655e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1507.4557684642448 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.133556625622163, dt = 0.01111587305990721 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.5%)
   patch tree reduce : 1080.00 ns (0.4%)
   gen split merge   : 669.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1010.00 ns (0.4%)
   LB compute        : 271.70 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1757.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.922550198686706e-18,-6.535592379786071e-17,6.797297100180622e-18)
    sum a = (1.3055230724604016e-16,-4.238796813549328e-17,-9.904967471219273e-17)
    sum e = 2.5920013799982544
    sum de = -1.6940658945086007e-20
Info: CFL hydro = 0.011113041456060265 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011113041456060265 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9797e+04 |  512 |      1 | 2.586e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1547.267067799068 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.14467249868207, dt = 0.011113041456060265 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.69 us    (1.5%)
   patch tree reduce : 963.00 ns  (0.3%)
   gen split merge   : 689.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1384.00 ns (0.5%)
   LB compute        : 285.92 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0819470319667346e-17,-6.507197124888675e-17,4.519822016657571e-18)
    sum a = (1.5982430223021592e-16,-8.736371001627497e-17,-3.618199490018625e-17)
    sum e = 2.5920013837989155
    sum de = -4.743384504624082e-19
Info: CFL hydro = 0.011106797734120438 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011106797734120438 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9565e+04 |  512 |      1 | 2.617e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.742950445041 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.15578554013813, dt = 0.011106797734120438 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.1%)
   patch tree reduce : 1249.00 ns (0.3%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 959.00 ns  (0.2%)
   LB compute        : 382.00 us  (96.0%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (70.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2763227974499358e-17,-6.625461897863394e-17,4.519822016657571e-18)
    sum a = (-2.64924800846833e-18,2.879337393513204e-17,-4.8757872739280116e-17)
    sum e = 2.5920013869486587
    sum de = 2.337810934421869e-18
Info: CFL hydro = 0.011101287170897865 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011101287170897865 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8665e+04 |  512 |      1 | 2.743e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1457.6441986902491 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.16689233787225, dt = 0.011101287170897865 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.14 us    (1.7%)
   patch tree reduce : 885.00 ns  (0.3%)
   gen split merge   : 986.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 957.00 ns  (0.3%)
   LB compute        : 292.01 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1846.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1961135207294582e-17,-6.53003042264122e-17,3.86995123446976e-18)
    sum a = (-1.587382569140372e-16,8.744567570051487e-17,-3.470661258386798e-17)
    sum e = 2.5920013892602474
    sum de = 2.476724337771574e-18
Info: CFL hydro = 0.01109659858620568 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01109659858620568 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9436e+04 |  512 |      1 | 2.634e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1517.082003170634 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.177993625043149, dt = 0.01109659858620568 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.4%)
   patch tree reduce : 1095.00 ns (0.3%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1007.00 ns (0.3%)
   LB compute        : 303.32 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.63 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.226994168720637e-18,-6.459188652691017e-17,3.536233805778721e-18)
    sum a = (-1.0421936751103811e-16,3.474174073425651e-17,-1.7845100397373413e-17)
    sum e = 2.592001390558939
    sum de = -2.405573570202213e-19
Info: CFL hydro = 0.011092815171472203 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011092815171472203 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9166e+04 |  512 |      1 | 2.671e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1495.350897176381 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.189090223629353, dt = 0.011092815171472203 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.4%)
   patch tree reduce : 889.00 ns  (0.3%)
   gen split merge   : 854.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1003.00 ns (0.3%)
   LB compute        : 288.89 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.378063867664487e-18,-6.420547687263634e-17,3.331319595178961e-18)
    sum a = (-1.0139740609649284e-16,8.889763924990746e-17,1.0560692945138506e-16)
    sum e = 2.592001390753931
    sum de = -1.2976544751935881e-18
Info: CFL hydro = 0.011090012249833223 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011090012249833223 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9432e+04 |  512 |      1 | 2.635e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1515.6461689490766 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.200183038800827, dt = 0.011090012249833223 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1028.00 ns (0.4%)
   gen split merge   : 675.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1013.00 ns (0.3%)
   LB compute        : 276.56 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.61 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.441313190637011e-18,-6.310772217299477e-17,5.257513174816708e-18)
    sum a = (2.4970260234513653e-17,1.0964666674606605e-16,4.812556603228657e-18)
    sum e = 2.592001389839411
    sum de = 7.301424005332069e-19
Info: CFL hydro = 0.011088256128866015 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011088256128866015 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9058e+04 |  512 |      1 | 2.687e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1486.0569199445824 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.211273051050659, dt = 0.011088256128866015 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 1076.00 ns (0.3%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 993.00 ns  (0.3%)
   LB compute        : 297.48 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.366354484201643e-18,-6.145377175886813e-17,4.7042448061973555e-18)
    sum a = (-8.76681539863089e-17,5.607623740355727e-17,-1.1667229682377212e-16)
    sum e = 2.5920013879013175
    sum de = -1.4378384279641748e-18
Info: CFL hydro = 0.01108760318064977 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01108760318064977 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9247e+04 |  512 |      1 | 2.660e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1500.578916081036 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.222361307179526, dt = 0.01108760318064977 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.4%)
   patch tree reduce : 1143.00 ns (0.4%)
   gen split merge   : 1018.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 906.00 ns  (0.3%)
   LB compute        : 287.56 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.6684938820893436e-18,-6.114347309710277e-17,2.8395254897395363e-18)
    sum a = (1.1306580671721633e-16,-1.9064047215855417e-16,7.734047777208098e-17)
    sum e = 2.5920013851083747
    sum de = 3.3690735477039796e-19
Info: CFL hydro = 0.011088098133670562 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011088098133670562 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8917e+04 |  512 |      1 | 2.706e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1474.7982890924752 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.233448910360176, dt = 0.011088098133670562 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.08 us    (1.7%)
   patch tree reduce : 1703.00 ns (0.6%)
   gen split merge   : 876.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1015.00 ns (0.3%)
   LB compute        : 279.96 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 3.38 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.174301943137841e-18,-6.475874524125569e-17,4.786210490437259e-18)
    sum a = (-9.824758194498795e-17,-2.9203202356331556e-17,9.092336258897937e-17)
    sum e = 2.5920013816972487
    sum de = -3.2441361879839703e-19
Info: CFL hydro = 0.011089773502470106 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011089773502470106 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8717e+04 |  512 |      1 | 2.735e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1459.2440759847345 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.244537008493847, dt = 0.011089773502470106 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 948.00 ns  (0.3%)
   gen split merge   : 3.83 us    (1.2%)
   split / merge op  : 0/0
   apply split merge : 1335.00 ns (0.4%)
   LB compute        : 286.44 us  (93.2%)
   LB move op cnt    : 0
   LB apply          : 3.86 us    (1.3%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1873.00 ns (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.844134634031995e-18,-6.41966948350392e-17,5.878110498347411e-18)
    sum a = (-5.497555535804999e-17,-2.1451590503929196e-17,1.769287841235645e-17)
    sum e = 2.5920013779590394
    sum de = -1.861778418064952e-18
Info: CFL hydro = 0.011092648616085183 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011092648616085183 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8714e+04 |  512 |      1 | 2.736e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1459.2495263443482 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.255626781996316, dt = 0.011092648616085183 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.56 us    (1.5%)
   patch tree reduce : 1278.00 ns (0.4%)
   gen split merge   : 814.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1028.00 ns (0.3%)
   LB compute        : 293.23 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.510417205340957e-18,-6.445137392535604e-17,5.6497775208219635e-18)
    sum a = (-1.002264677502085e-16,-6.456554041411877e-17,-8.360499792470221e-18)
    sum e = 2.59200137421825
    sum de = -4.845028458294598e-19
Info: CFL hydro = 0.011096728431383297 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011096728431383297 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9154e+04 |  512 |      1 | 2.673e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1493.9219078303968 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.266719430612401, dt = 0.011096728431383297 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.56 us    (1.5%)
   patch tree reduce : 990.00 ns  (0.3%)
   gen split merge   : 722.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 990.00 ns  (0.3%)
   LB compute        : 279.28 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.953069204782778e-18,-6.542032540690634e-17,5.409735159833673e-18)
    sum a = (1.7820510692101444e-16,-1.0289035248800537e-16,4.643941481363711e-17)
    sum e = 2.592001370808604
    sum de = 1.497554250745603e-18
Info: CFL hydro = 0.011102003096385794 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011102003096385794 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9083e+04 |  512 |      1 | 2.683e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1488.9657825647903 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.277816159043784, dt = 0.011102003096385794 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.4%)
   patch tree reduce : 1097.00 ns (0.4%)
   gen split merge   : 739.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 966.00 ns  (0.3%)
   LB compute        : 278.69 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1976.00 ns (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.565414003069982e-18,-6.657955436972784e-17,6.191336505978473e-18)
    sum a = (1.713258441365939e-16,5.5338546245398136e-17,-3.588340562188375e-17)
    sum e = 2.5920013680440537
    sum de = 5.89534931288993e-19
Info: CFL hydro = 0.011103840757210739 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011103840757210739 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9009e+04 |  512 |      1 | 2.694e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1483.824686595393 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.28891816214017, dt = 0.011103840757210739 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.6%)
   patch tree reduce : 1009.00 ns (0.3%)
   gen split merge   : 727.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1131.00 ns (0.4%)
   LB compute        : 276.83 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.44 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1961.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0327676214227921e-17,-6.543788948210061e-17,5.40095312223654e-18)
    sum a = (-2.9267603965377195e-17,-1.811090340197996e-16,-3.9683100555576445e-17)
    sum e = 2.5920013661486228
    sum de = 4.3029273720518457e-19
Info: CFL hydro = 0.01110357136187965 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01110357136187965 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8913e+04 |  512 |      1 | 2.707e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1476.621204088658 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.30002200289738, dt = 0.01110357136187965 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.5%)
   patch tree reduce : 987.00 ns  (0.3%)
   gen split merge   : 733.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 974.00 ns  (0.3%)
   LB compute        : 280.48 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.34 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1854.00 ns (64.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.03378934158372e-18,-6.864040585918829e-17,4.976487971708465e-18)
    sum a = (-8.544922582010006e-17,1.6393136847980826e-18,2.4133039316920345e-17)
    sum e = 2.5920013653529184
    sum de = 1.9447876468958736e-18
Info: CFL hydro = 0.011104745848545844 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011104745848545844 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9075e+04 |  512 |      1 | 2.684e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1489.2261019678042 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.31112557425926, dt = 0.011104745848545844 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.5%)
   patch tree reduce : 1466.00 ns (0.5%)
   gen split merge   : 858.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 947.00 ns  (0.3%)
   LB compute        : 275.48 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.903833837419328e-18,-6.754557850541243e-17,5.597085295239168e-18)
    sum a = (-8.852586632496217e-17,4.018074935274729e-17,3.674989999813416e-17)
    sum e = 2.592001365825754
    sum de = 3.8624702394796095e-19
Info: CFL hydro = 0.011107357831028453 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011107357831028453 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9216e+04 |  512 |      1 | 2.665e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1500.3522990527888 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.322230320107805, dt = 0.011107357831028453 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.6%)
   patch tree reduce : 1093.00 ns (0.4%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1115.00 ns (0.4%)
   LB compute        : 280.11 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1859.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.686057957283609e-18,-6.726455330230418e-17,6.0742426713500384e-18)
    sum a = (4.36877096998689e-17,7.143894850680788e-17,-5.50341022753642e-19)
    sum e = 2.592001367603497
    sum de = -9.385125055577648e-19
Info: CFL hydro = 0.01111138186523772 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01111138186523772 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8998e+04 |  512 |      1 | 2.695e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1483.7444907744448 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.333337677938832, dt = 0.01111138186523772 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.95 us    (1.6%)
   patch tree reduce : 1115.00 ns (0.4%)
   gen split merge   : 742.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1005.00 ns (0.3%)
   LB compute        : 286.30 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.45 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1957.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.549624987668313e-18,-6.607019618909415e-17,5.80785419757035e-18)
    sum a = (-6.900486041946929e-17,-2.03479811125562e-17,5.318987437996636e-17)
    sum e = 2.5920013706299154
    sum de = -1.1689054672109345e-18
Info: CFL hydro = 0.011116773307617027 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011116773307617027 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8598e+04 |  512 |      1 | 2.753e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1453.0053125976049 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.34444905980407, dt = 0.011116773307617027 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 1146.00 ns (0.4%)
   gen split merge   : 747.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1406.00 ns (0.5%)
   LB compute        : 277.01 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.5396906639980654e-18,-6.709476724209296e-17,6.729968145269272e-18)
    sum a = (2.7123689036977205e-17,1.778322362413695e-16,1.1790178208737068e-16)
    sum e = 2.5920013747568027
    sum de = 1.0062751413381088e-18
Info: CFL hydro = 0.011123470137632721 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011123470137632721 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8806e+04 |  512 |      1 | 2.723e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1469.945464790545 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.355565833111687, dt = 0.011123470137632721 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.5%)
   patch tree reduce : 1603.00 ns (0.5%)
   gen split merge   : 852.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1069.00 ns (0.4%)
   LB compute        : 283.82 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1953.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.461804611696986e-18,-6.369904603786835e-17,8.410264672187306e-18)
    sum a = (1.3646700956770895e-16,-3.486908027941493e-17,-2.3127496012048666e-17)
    sum e = 2.592001379750718
    sum de = -1.6466320494623599e-18
Info: CFL hydro = 0.01113138947944163 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01113138947944163 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9132e+04 |  512 |      1 | 2.676e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1496.364250109395 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.36668930324932, dt = 0.01113138947944163 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.79 us    (1.6%)
   patch tree reduce : 897.00 ns  (0.3%)
   gen split merge   : 766.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1306.00 ns (0.4%)
   LB compute        : 276.15 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1841.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.569493635008808e-18,-6.502806106090109e-17,7.365202198128529e-18)
    sum a = (-3.399819488436595e-17,-5.2396563650358715e-17,4.639111360685288e-18)
    sum e = 2.5920013853115753
    sum de = -9.825582188149884e-20
Info: CFL hydro = 0.011140431379583843 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011140431379583843 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9273e+04 |  512 |      1 | 2.657e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1508.4387238815304 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.377820692728761, dt = 0.011140431379583843 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.5%)
   patch tree reduce : 898.00 ns  (0.3%)
   gen split merge   : 627.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 972.00 ns  (0.3%)
   LB compute        : 272.70 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1885.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.892124453956484e-18,-6.615801656506549e-17,7.614026596713952e-18)
    sum a = (-2.0801719721741385e-17,-9.883305111813012e-17,8.296976387184296e-17)
    sum e = 2.5920013910888065
    sum de = -4.0657581468206416e-19
Info: CFL hydro = 0.01115047930048411 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115047930048411 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8260e+04 |  512 |      1 | 2.804e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1430.3548231984494 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.388961124108345, dt = 0.01115047930048411 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1100.00 ns (0.4%)
   gen split merge   : 790.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 886.00 ns  (0.3%)
   LB compute        : 292.66 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.003363596853496e-18,-6.707720316689869e-17,8.975242424269502e-18)
    sum a = (6.301404710529201e-17,-4.035639010468994e-17,-3.1026938830669426e-17)
    sum e = 2.5920013967071243
    sum de = -6.471331717022855e-19
Info: CFL hydro = 0.011161401627261557 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011161401627261557 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9246e+04 |  512 |      1 | 2.660e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1508.913445270908 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.40011160340883, dt = 0.011161401627261557 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.4%)
   patch tree reduce : 935.00 ns  (0.3%)
   gen split merge   : 685.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1558.00 ns (0.5%)
   LB compute        : 301.86 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1915.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.080626875435094e-18,-6.7428484670784e-17,7.971162792330677e-18)
    sum a = (-1.1498029091339125e-16,1.6334589930666609e-18,-2.873189967195211e-17)
    sum e = 2.592001401794336
    sum de = -4.438452643612534e-19
Info: CFL hydro = 0.01116160821846384 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01116160821846384 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9033e+04 |  512 |      1 | 2.690e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1493.7045730051636 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.41127300503609, dt = 0.01116160821846384 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1115.00 ns (0.4%)
   gen split merge   : 732.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 976.00 ns  (0.3%)
   LB compute        : 285.64 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1942.00 ns (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.680203265552187e-18,-6.709183989622724e-17,7.657936784699615e-18)
    sum a = (3.3377597560835247e-17,1.3735106801915364e-17,-4.4308307023399603e-17)
    sum e = 2.5920014058198357
    sum de = -7.945169045245337e-19
Info: CFL hydro = 0.011161052325261267 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011161052325261267 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8802e+04 |  512 |      1 | 2.723e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1475.6022923797323 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.422434613254554, dt = 0.011161052325261267 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 943.00 ns  (0.3%)
   gen split merge   : 782.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1019.00 ns (0.3%)
   LB compute        : 284.19 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.687210243356724e-18,-6.676983185099905e-17,6.999283964914671e-18)
    sum a = (-2.0946916076680643e-16,1.0894995843002686e-16,-7.329488578566856e-17)
    sum e = 2.5920014086421865
    sum de = -6.522153693858113e-20
Info: CFL hydro = 0.011161197627120093 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011161197627120093 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8788e+04 |  512 |      1 | 2.725e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1474.3978842147026 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.433595665579816, dt = 0.011161197627120093 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.5%)
   patch tree reduce : 954.00 ns  (0.3%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 277.62 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1839.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.221232738355063e-18,-6.492853130146692e-17,5.957148836721604e-18)
    sum a = (-2.9021706912657485e-17,5.998717148014698e-17,-9.684831062117816e-17)
    sum e = 2.5920014100855537
    sum de = -1.2900311786682994e-18
Info: CFL hydro = 0.011161995075216456 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011161995075216456 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9285e+04 |  512 |      1 | 2.655e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1513.406156970352 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.444756863206935, dt = 0.011161995075216456 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1125.00 ns (0.4%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1007.00 ns (0.3%)
   LB compute        : 276.34 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.865248828811453e-18,-6.483778357962988e-17,4.7247362272573315e-18)
    sum a = (-2.7247735318036704e-17,9.50801937182888e-17,5.523316179423254e-17)
    sum e = 2.5920014100464996
    sum de = -2.4794771948501507e-18
Info: CFL hydro = 0.011163390645243312 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011163390645243312 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9258e+04 |  512 |      1 | 2.659e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1511.3983536758878 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.455918858282152, dt = 0.011163390645243312 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.5%)
   patch tree reduce : 1390.00 ns (0.5%)
   gen split merge   : 818.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 911.00 ns  (0.3%)
   LB compute        : 278.22 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1912.00 ns (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.549095475314679e-18,-6.351169590246286e-17,6.229392002232714e-18)
    sum a = (6.482314685030133e-17,-8.633328427154474e-17,7.161458925875053e-17)
    sum e = 2.592001408522143
    sum de = 1.0393094262810265e-18
Info: CFL hydro = 0.011165326205767732 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011165326205767732 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9202e+04 |  512 |      1 | 2.666e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1507.19076553279 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 14.467082248927396, dt = 0.011165326205767732 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.6%)
   patch tree reduce : 935.00 ns  (0.3%)
   gen split merge   : 685.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1340.00 ns (0.5%)
   LB compute        : 275.07 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1938.00 ns (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.743452588524711e-18,-6.58945554371515e-17,7.210052867245854e-18)
    sum a = (6.759827073099523e-17,6.40620369252165e-17,3.3635203997017806e-17)
    sum e = 2.5920014056142224
    sum de = 1.277325684459485e-18
Info: CFL hydro = 0.01116129408901215 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01116129408901215 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9122e+04 |  512 |      1 | 2.678e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1501.1823170551959 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.478247575133164, dt = 0.01116129408901215 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.5%)
   patch tree reduce : 1296.00 ns (0.4%)
   gen split merge   : 935.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 955.00 ns  (0.3%)
   LB compute        : 272.21 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.592382889580861e-18,-6.394201574472235e-17,7.26859978456007e-18)
    sum a = (-7.638030832812781e-17,-4.535044215159267e-17,-4.1755661428499734e-17)
    sum e = 2.592001401425813
    sum de = -1.0740377771184528e-18
Info: CFL hydro = 0.011157118010358713 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011157118010358713 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9287e+04 |  512 |      1 | 2.655e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1513.5899814659363 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.489408869222176, dt = 0.01059113077782392 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.4%)
   patch tree reduce : 931.00 ns  (0.3%)
   gen split merge   : 637.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 958.00 ns  (0.3%)
   LB compute        : 278.66 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1886.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.152128723651117e-18,-6.515100958726095e-17,6.463579671489583e-18)
    sum a = (4.89686416416113e-17,6.128691304452261e-17,-1.0693594447441778e-16)
    sum e = 2.5920013884377693
    sum de = 3.3881317890172014e-21
Info: CFL hydro = 0.011154515616993743 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011154515616993743 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9101e+04 |  512 |      1 | 2.681e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1422.40244625929 (tsim/hr)                              [sph::Model][rank=0]
Info: iteration since start : 1661                                                    [SPH][rank=0]
Info: time since start : 1795.3209812230002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14989462555835104 max=0.15009051353045327 delta=0.00019588797210223774
Number of particle pairs: 130816
Distance min=0.129144 max=1.975205 mean=0.800599
---------------- t = 14.5, dt = 0.011154515616993743 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 10.26 us   (1.6%)
   patch tree reduce : 1310.00 ns (0.2%)
   gen split merge   : 473.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 844.00 ns  (0.1%)
   LB compute        : 629.76 us  (96.1%)
   LB move op cnt    : 0
   LB apply          : 5.80 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.06 us    (75.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.299648303009775e-18,-6.366684523334553e-17,4.792065182168681e-18)
    sum a = (-1.4758506916567881e-16,1.2969898592618544e-16,-1.145938812591174e-16)
    sum e = 2.5920013911721003
    sum de = -3.7269449679189215e-20
Info: CFL hydro = 0.011153042826621835 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011153042826621835 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6949e+04 |  512 |      1 | 3.021e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1329.3508310169861 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.511154515616994, dt = 0.011153042826621835 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.4%)
   patch tree reduce : 1411.00 ns (0.4%)
   gen split merge   : 625.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1585.00 ns (0.5%)
   LB compute        : 308.91 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.62 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.553797880972986e-18,-6.183725406727624e-17,3.536233805778721e-18)
    sum a = (-2.0971505781952615e-17,-2.485902109161664e-17,-5.971785566050158e-18)
    sum e = 2.5920013853900765
    sum de = -1.4264034831762418e-18
Info: CFL hydro = 0.011151573984752956 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011151573984752956 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9376e+04 |  512 |      1 | 2.642e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1519.4614995899294 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.522307558443616, dt = 0.011151573984752956 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.4%)
   patch tree reduce : 1310.00 ns (0.4%)
   gen split merge   : 655.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 901.00 ns  (0.3%)
   LB compute        : 277.29 us  (90.9%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.42 us    (70.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.951916918709664e-18,-6.297013691730635e-17,4.083647482666652e-18)
    sum a = (1.988721687329331e-16,-8.823020439252538e-17,5.318401968823494e-17)
    sum e = 2.5920013799243544
    sum de = -4.336808689942018e-19
Info: CFL hydro = 0.011151464808131941 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011151464808131941 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9832e+04 |  512 |      1 | 2.582e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1555.0533531948695 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.53345913242837, dt = 0.011151464808131941 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.3%)
   patch tree reduce : 1237.00 ns (0.4%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 955.00 ns  (0.3%)
   LB compute        : 292.19 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.400330348517059e-18,-6.429329724860766e-17,4.996979392768441e-18)
    sum a = (5.1532996619974013e-17,4.999906738634152e-18,4.550266413660964e-17)
    sum e = 2.592001375113511
    sum de = 4.336808689942018e-19
Info: CFL hydro = 0.011147312554837013 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011147312554837013 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9491e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.2382903092798 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.5446105972365, dt = 0.011147312554837013 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.66 us    (1.6%)
   patch tree reduce : 1362.00 ns (0.5%)
   gen split merge   : 691.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 947.00 ns  (0.3%)
   LB compute        : 277.55 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1841.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.107595761945973e-18,-6.374881091758545e-17,5.491700844073577e-18)
    sum a = (-3.388695574146894e-17,-9.269733418360015e-17,-6.252225299985258e-17)
    sum e = 2.5920013712448
    sum de = -2.4462311516704194e-18
Info: CFL hydro = 0.011143669910558004 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011143669910558004 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8735e+04 |  512 |      1 | 2.733e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1468.4404658300823 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.555757909791337, dt = 0.011143669910558004 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1283.00 ns (0.4%)
   gen split merge   : 685.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 281.44 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.31721237820404e-18,-6.514222754966381e-17,4.221232738355063e-18)
    sum a = (-6.149182725512237e-17,-3.8538508322083496e-17,-1.5472486573214761e-16)
    sum e = 2.592001368652536
    sum de = 1.2332799712022613e-18
Info: CFL hydro = 0.011141442554758943 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011141442554758943 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8884e+04 |  512 |      1 | 2.711e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1479.6641828074683 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.566901579701895, dt = 0.011141442554758943 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.83 us    (1.6%)
   patch tree reduce : 1424.00 ns (0.5%)
   gen split merge   : 660.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 950.00 ns  (0.3%)
   LB compute        : 290.24 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.362897625982299e-18,-6.543496213623489e-17,2.0023045721462296e-18)
    sum a = (-7.314266380065159e-17,-2.0752540311197443e-16,-5.608209209528869e-17)
    sum e = 2.5920013675371365
    sum de = -2.15485181781494e-18
Info: CFL hydro = 0.011140660351529375 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011140660351529375 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9070e+04 |  512 |      1 | 2.685e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1493.872381592671 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.578043022256654, dt = 0.011140660351529375 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 1238.00 ns (0.4%)
   gen split merge   : 731.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 965.00 ns  (0.3%)
   LB compute        : 299.07 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.38 us    (70.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.6369158512860054e-18,-6.862284178399402e-17,1.8969201209806384e-18)
    sum a = (-2.6539317618534676e-17,8.629815612115621e-18,-2.3243126173744243e-18)
    sum e = 2.5920013679907927
    sum de = -9.554531645028508e-19
Info: CFL hydro = 0.011141331570382346 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011141331570382346 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9303e+04 |  512 |      1 | 2.652e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1512.0298576341388 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.589183682608184, dt = 0.011141331570382346 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.3%)
   patch tree reduce : 1384.00 ns (0.4%)
   gen split merge   : 756.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 990.00 ns  (0.3%)
   LB compute        : 324.80 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.46 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.250506197012172e-18,-6.727040799403561e-17,2.0901249481175553e-18)
    sum a = (4.011342039783594e-17,1.9237144836077233e-17,-3.364984072634636e-18)
    sum e = 2.5920013700022633
    sum de = 2.642742795433417e-19
Info: CFL hydro = 0.011143442780881715 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011143442780881715 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8771e+04 |  512 |      1 | 2.728e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1470.4866417201836 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.600325014178566, dt = 0.011143442780881715 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.6%)
   patch tree reduce : 1161.00 ns (0.4%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 962.00 ns  (0.3%)
   LB compute        : 274.76 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1853.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.5619571448506374e-18,-6.692790852774744e-17,2.0696335270575793e-18)
    sum a = (-6.345022163928294e-17,-3.0590764296678507e-18,-2.208389721092274e-17)
    sum e = 2.5920013734575265
    sum de = 2.4936649967166602e-18
Info: CFL hydro = 0.011146958996061374 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011146958996061374 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8857e+04 |  512 |      1 | 2.715e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1477.489917164889 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.611468456959447, dt = 0.011146958996061374 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.4%)
   patch tree reduce : 1203.00 ns (0.4%)
   gen split merge   : 712.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 990.00 ns  (0.3%)
   LB compute        : 288.60 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1796.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.010463836023881e-18,-6.723820718951279e-17,1.738843444232252e-18)
    sum a = (2.1731152034104582e-17,-5.0525989642169474e-18,-3.475710930005149e-17)
    sum e = 2.5920013781476094
    sum de = -5.353248226647178e-19
Info: CFL hydro = 0.011151701929958135 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011151701929958135 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9287e+04 |  512 |      1 | 2.655e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1511.6514002777146 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.622615415955508, dt = 0.011151701929958135 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.4%)
   patch tree reduce : 13.77 us   (4.3%)
   gen split merge   : 932.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 958.00 ns  (0.3%)
   LB compute        : 287.90 us  (90.7%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.029180197291261e-18,-6.730553614442414e-17,1.2646134139870923e-18)
    sum a = (1.0040210850215114e-16,5.866401114884568e-17,4.7415684659851685e-17)
    sum e = 2.592001383781272
    sum de = 5.759824041329242e-19
Info: CFL hydro = 0.011151080121142597 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011151080121142597 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9282e+04 |  512 |      1 | 2.655e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1511.9348150436956 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.633767117885466, dt = 0.011151080121142597 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.3%)
   patch tree reduce : 1514.00 ns (0.5%)
   gen split merge   : 978.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 295.29 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.5396906639980654e-18,-6.585649994089726e-17,2.1369624819689293e-18)
    sum a = (1.0991305521984574e-16,3.708947211855662e-18,3.043268761993012e-17)
    sum e = 2.592001389924449
    sum de = 1.2536087619363645e-18
Info: CFL hydro = 0.011150861883369648 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011150861883369648 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9647e+04 |  512 |      1 | 2.606e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1540.4493576677226 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.644918198006609, dt = 0.011150861883369648 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.91 us    (1.3%)
   patch tree reduce : 1092.00 ns (0.4%)
   gen split merge   : 689.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1217.00 ns (0.4%)
   LB compute        : 284.15 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1848.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.716483702013832e-18,-6.63804948508595e-17,2.397496264017196e-18)
    sum a = (9.945364844166082e-17,-3.090106295844386e-17,-8.584734485783674e-17)
    sum e = 2.592001396239451
    sum de = -3.5914196963582334e-19
Info: CFL hydro = 0.011151044769009487 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011151044769009487 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9222e+04 |  512 |      1 | 2.664e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1507.1150787196793 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.656069059889978, dt = 0.011151044769009487 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.4%)
   patch tree reduce : 1127.00 ns (0.4%)
   gen split merge   : 725.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 866.00 ns  (0.3%)
   LB compute        : 283.95 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.6239609203842e-18,-6.724113453537849e-17,9.250412935646324e-19)
    sum a = (1.6202273897536478e-16,-2.0432874142661817e-18,-4.5485100061415374e-17)
    sum e = 2.5920014023250317
    sum de = -1.2841019480375193e-18
Info: CFL hydro = 0.011151619852639155 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011151619852639155 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9680e+04 |  512 |      1 | 2.602e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1543.0280240307807 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.667220104658988, dt = 0.011151619852639155 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.95 us    (1.3%)
   patch tree reduce : 1071.00 ns (0.3%)
   gen split merge   : 739.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 876.00 ns  (0.3%)
   LB compute        : 292.03 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0842889086593032e-17,-6.728504472336417e-17,6.967083160391852e-19)
    sum a = (6.830083373876583e-17,-8.614593413613925e-17,3.987045069098194e-17)
    sum e = 2.592001407800403
    sum de = 5.116079001415974e-19
Info: CFL hydro = 0.011152571733959612 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011152571733959612 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8957e+04 |  512 |      1 | 2.701e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1486.4136559839121 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.678371724511626, dt = 0.011152571733959612 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.78 us    (1.5%)
   patch tree reduce : 1125.00 ns (0.4%)
   gen split merge   : 890.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1062.00 ns (0.3%)
   LB compute        : 302.42 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1905.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1328828500301035e-17,-6.7914424084492e-17,1.548565962961046e-18)
    sum a = (5.592401541854031e-17,6.701865624958448e-17,4.9946375160758725e-17)
    sum e = 2.592001412326653
    sum de = -2.354751593366955e-19
Info: CFL hydro = 0.011153879165682347 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011153879165682347 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9154e+04 |  512 |      1 | 2.673e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1501.9511413657144 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.689524296245585, dt = 0.011153879165682347 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1070.00 ns (0.4%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 844.00 ns  (0.3%)
   LB compute        : 277.74 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1903.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1621563086872122e-17,-6.65414988734736e-17,2.1750179782231704e-18)
    sum a = (-2.478876479083958e-17,-3.413285279418865e-18,7.883342416359351e-17)
    sum e = 2.5920014156326725
    sum de = -1.1299419516372367e-18
Info: CFL hydro = 0.011155515215482742 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011155515215482742 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9706e+04 |  512 |      1 | 2.598e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1545.4226252492906 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.700678175411268, dt = 0.011155515215482742 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.4%)
   patch tree reduce : 1223.00 ns (0.4%)
   gen split merge   : 676.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 842.00 ns  (0.3%)
   LB compute        : 272.88 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.73 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0930709462564358e-17,-6.675226777580479e-17,3.1937343394905505e-18)
    sum a = (1.1931861748637473e-17,-4.037395417988421e-17,4.521578424176997e-17)
    sum e = 2.592001417538135
    sum de = 2.922263668027336e-20
Info: CFL hydro = 0.011157448432853856 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011157448432853856 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8793e+04 |  512 |      1 | 2.724e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1474.0899049706986 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.71183369062675, dt = 0.011157448432853856 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.4%)
   patch tree reduce : 1085.00 ns (0.4%)
   gen split merge   : 624.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 838.00 ns  (0.3%)
   LB compute        : 270.87 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1796.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1205879973941179e-17,-6.779733024986356e-17,3.536233805778721e-18)
    sum a = (1.583108644176434e-17,-4.507527164021585e-17,1.246463869619685e-16)
    sum e = 2.592001417957621
    sum de = 3.494010907423989e-19
Info: CFL hydro = 0.01115558433782895 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115558433782895 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9736e+04 |  512 |      1 | 2.594e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1548.2721811733088 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.722991139059605, dt = 0.01115558433782895 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.72 us    (1.6%)
   patch tree reduce : 949.00 ns  (0.3%)
   gen split merge   : 649.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 685.00 ns  (0.2%)
   LB compute        : 275.00 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1779.00 ns (63.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1691819387649182e-17,-6.865211524265113e-17,5.374607009445143e-18)
    sum a = (4.378138476757165e-17,7.034997584476344e-17,-2.8740681709549244e-17)
    sum e = 2.5920014168439742
    sum de = -1.1460355776350684e-18
Info: CFL hydro = 0.011141673288865627 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011141673288865627 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9514e+04 |  512 |      1 | 2.624e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1530.6309920869792 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.734146723397433, dt = 0.011141673288865627 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1769.00 ns (0.6%)
   gen split merge   : 582.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 830.00 ns  (0.3%)
   LB compute        : 276.72 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1888.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2382673011956945e-17,-6.722357046018424e-17,4.1861045879665326e-18)
    sum a = (-1.892470555264758e-16,2.2458597481733734e-17,9.490455296634615e-17)
    sum e = 2.5920014141968477
    sum de = -5.759824041329242e-20
Info: CFL hydro = 0.011127682720334304 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011127682720334304 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9270e+04 |  512 |      1 | 2.657e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.609493872997 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.745288396686298, dt = 0.011127682720334304 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.5%)
   patch tree reduce : 1372.00 ns (0.5%)
   gen split merge   : 663.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 813.00 ns  (0.3%)
   LB compute        : 279.29 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1930.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.981097116000924e-18,-6.675519512167049e-17,5.901529265273098e-18)
    sum a = (-4.782112206225264e-17,1.0702376485038912e-17,-5.3816326395228486e-17)
    sum e = 2.5920014104385465
    sum de = 2.236166980751353e-18
Info: CFL hydro = 0.01111450125775336 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01111450125775336 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9816e+04 |  512 |      1 | 2.584e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1550.4548198290504 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.756416079406632, dt = 0.01111450125775336 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.4%)
   patch tree reduce : 1265.00 ns (0.4%)
   gen split merge   : 641.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 972.00 ns  (0.3%)
   LB compute        : 277.29 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1856.00 ns (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.215284785257793e-18,-6.719429700152713e-17,4.391018798566293e-18)
    sum a = (8.034978932203174e-17,-9.57271371546109e-17,-1.193654550202261e-16)
    sum e = 2.592001405879224
    sum de = 1.2197274440461925e-19
Info: CFL hydro = 0.011102279147535478 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011102279147535478 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9304e+04 |  512 |      1 | 2.652e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1508.5694741446 (tsim/hr)                               [sph::Model][rank=0]
---------------- t = 14.767530580664385, dt = 0.011102279147535478 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1182.00 ns (0.4%)
   gen split merge   : 639.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 933.00 ns  (0.3%)
   LB compute        : 282.97 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.40 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1850.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0807760936204502e-17,-6.881897395699665e-17,2.7253590009768125e-18)
    sum a = (1.1803058530546196e-17,-8.583270812850819e-17,2.3184579256430027e-17)
    sum e = 2.592001400864042
    sum de = -4.2012834183813297e-19
Info: CFL hydro = 0.011091152982966038 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011091152982966038 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9677e+04 |  512 |      1 | 2.602e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.0158053835416 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.778632859811921, dt = 0.011091152982966038 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1171.00 ns (0.4%)
   gen split merge   : 688.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1281.00 ns (0.4%)
   LB compute        : 275.85 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0418423936064958e-17,-6.986989112278686e-17,3.896297347261157e-18)
    sum a = (6.93429688669589e-17,-9.023543631053732e-17,-8.0853292810934e-18)
    sum e = 2.592001395761685
    sum de = 2.303929616531697e-18
Info: CFL hydro = 0.011081239711272905 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011081239711272905 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9015e+04 |  512 |      1 | 2.693e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1482.895614565871 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.789724012794887, dt = 0.011081239711272905 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.4%)
   patch tree reduce : 1578.00 ns (0.5%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 940.00 ns  (0.3%)
   LB compute        : 291.27 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1706456116977737e-17,-7.059880024334886e-17,3.577216647898673e-18)
    sum a = (6.173186961611065e-17,-2.8765564149407784e-17,5.395098430505119e-17)
    sum e = 2.592001390935079
    sum de = -1.3552527156068805e-20
Info: CFL hydro = 0.011072638605610035 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011072638605610035 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9253e+04 |  512 |      1 | 2.659e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1500.1291881802254 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.800805252506159, dt = 0.011072638605610035 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.79 us    (1.2%)
   patch tree reduce : 1565.00 ns (0.5%)
   gen split merge   : 616.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1729.00 ns (0.6%)
   LB compute        : 287.82 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2183613493088607e-17,-7.061929166440883e-17,4.537386091851836e-18)
    sum a = (7.278552760503487e-17,3.177194835349284e-17,-3.9747502164622083e-17)
    sum e = 2.592001386725326
    sum de = 4.54009659728305e-19
Info: CFL hydro = 0.011065430147421017 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011065430147421017 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9698e+04 |  512 |      1 | 2.599e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.582205213519 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.811877891111768, dt = 0.011065430147421017 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.4%)
   patch tree reduce : 1118.00 ns (0.4%)
   gen split merge   : 578.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1005.00 ns (0.3%)
   LB compute        : 276.56 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.61 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1895.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2731027169976539e-17,-6.971474179190418e-17,3.580143993764384e-18)
    sum a = (4.4003863053365675e-17,-1.20186575535558e-16,-3.0526362687632867e-17)
    sum e = 2.592001383420988
    sum de = 3.3203691532368573e-19
Info: CFL hydro = 0.011059676142240637 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011059676142240637 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9466e+04 |  512 |      1 | 2.630e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1514.5594947435095 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.822943321259189, dt = 0.011059676142240637 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.08 us    (1.3%)
   patch tree reduce : 1263.00 ns (0.4%)
   gen split merge   : 671.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 952.00 ns  (0.3%)
   LB compute        : 299.53 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3348697147641531e-17,-7.188683242426164e-17,3.2581359485361892e-18)
    sum a = (2.1357915436226448e-17,7.72672941254382e-17,4.224745553393916e-17)
    sum e = 2.5920013812453075
    sum de = -1.6466320494623599e-18
Info: CFL hydro = 0.011055419310750172 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011055419310750172 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9341e+04 |  512 |      1 | 2.647e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1503.9871070981644 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.834002997401429, dt = 0.011055419310750172 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.5%)
   patch tree reduce : 1426.00 ns (0.5%)
   gen split merge   : 604.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 876.00 ns  (0.3%)
   LB compute        : 277.24 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1998.00 ns (64.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3307714305521579e-17,-7.000454903260955e-17,4.1275576706523154e-18)
    sum a = (-4.238796813549328e-18,-5.264538804894414e-17,-5.669683472708798e-17)
    sum e = 2.592001380340427
    sum de = -3.9979955110402976e-19
Info: CFL hydro = 0.011052682769249563 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011052682769249563 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9258e+04 |  512 |      1 | 2.659e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1496.9865259284127 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.84505841671218, dt = 0.011052682769249563 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1330.00 ns (0.5%)
   gen split merge   : 564.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1269.00 ns (0.4%)
   LB compute        : 277.34 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.68 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3544829320644159e-17,-7.132770936391086e-17,2.971256053696525e-18)
    sum a = (-8.697730036200114e-17,-6.207729642826454e-17,-2.740581199478509e-17)
    sum e = 2.59200138076241
    sum de = -9.215718466126788e-19
Info: CFL hydro = 0.011051469909732055 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011051469909732055 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8731e+04 |  512 |      1 | 2.733e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1455.6359209730488 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.85611109948143, dt = 0.011051469909732055 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.5%)
   patch tree reduce : 1300.00 ns (0.4%)
   gen split merge   : 658.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 862.00 ns  (0.3%)
   LB compute        : 276.47 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1980.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1896733598248942e-17,-7.221469516122125e-17,2.8805083318594883e-18)
    sum a = (1.354775666650987e-17,1.1459973595084883e-16,1.1587605874829876e-16)
    sum e = 2.592001382479532
    sum de = 1.9786689647860456e-18
Info: CFL hydro = 0.01105176528750419 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01105176528750419 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9365e+04 |  512 |      1 | 2.644e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1504.7445218977543 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.867162569391162, dt = 0.01105176528750419 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.5%)
   patch tree reduce : 1374.00 ns (0.5%)
   gen split merge   : 774.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1015.00 ns (0.3%)
   LB compute        : 282.03 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1904.00 ns (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2470493387928272e-17,-6.998698495741528e-17,4.879885558140007e-18)
    sum a = (-5.056111779255801e-17,6.509831736167815e-17,-2.6641774723834555e-17)
    sum e = 2.5920013853740014
    sum de = -7.318364664277155e-19
Info: CFL hydro = 0.01105353462689444 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01105353462689444 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9185e+04 |  512 |      1 | 2.669e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1490.793889748599 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.878214334678667, dt = 0.01105353462689444 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.5%)
   patch tree reduce : 1300.00 ns (0.4%)
   gen split merge   : 678.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 931.00 ns  (0.3%)
   LB compute        : 276.81 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.57 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1848.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1791349147083352e-17,-6.943957128052736e-17,3.913861422455422e-18)
    sum a = (-9.703566075658365e-17,-2.5725515467867056e-17,-3.4519262448462486e-17)
    sum e = 2.592001389252005
    sum de = 1.2739375526704677e-18
Info: CFL hydro = 0.011056724630458401 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011056724630458401 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9092e+04 |  512 |      1 | 2.682e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1483.844030846031 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.889267869305561, dt = 0.011056724630458401 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1567.00 ns (0.5%)
   gen split merge   : 714.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 980.00 ns  (0.3%)
   LB compute        : 282.89 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1863.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0149108116419558e-17,-7.03411938071663e-17,3.451340775673106e-18)
    sum a = (3.30672988990699e-17,5.792631999068653e-17,-1.3354551839372951e-17)
    sum e = 2.5920013938585424
    sum de = 1.1316360175317453e-18
Info: CFL hydro = 0.01106126538002086 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01106126538002086 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9341e+04 |  512 |      1 | 2.647e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1503.6352647255394 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.90032459393602, dt = 0.01106126538002086 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.3%)
   patch tree reduce : 1198.00 ns (0.4%)
   gen split merge   : 566.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 963.00 ns  (0.3%)
   LB compute        : 292.44 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1955.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1063903699454202e-17,-6.93458962128246e-17,3.506960347121612e-18)
    sum a = (-1.5414232390487115e-16,-1.47046437526388e-16,8.751593200129193e-17)
    sum e = 2.592001398893334
    sum de = -1.1519648082658485e-18
Info: CFL hydro = 0.011067070327405747 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011067070327405747 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9738e+04 |  512 |      1 | 2.594e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1535.1370454272828 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.911385859316042, dt = 0.011067070327405747 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.08 us    (1.3%)
   patch tree reduce : 1212.00 ns (0.4%)
   gen split merge   : 645.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 900.00 ns  (0.3%)
   LB compute        : 287.43 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1987.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.604933172257079e-18,-7.182243081521599e-17,4.999906738634152e-18)
    sum a = (3.5186697305844563e-17,3.6650370238699994e-18,-4.431269804219817e-17)
    sum e = 2.5920014040334642
    sum de = -1.5924219408380846e-18
Info: CFL hydro = 0.011074037324882205 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011074037324882205 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9673e+04 |  512 |      1 | 2.603e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1530.885160890611 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 14.922452929643446, dt = 0.011074037324882205 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.3%)
   patch tree reduce : 1258.00 ns (0.4%)
   gen split merge   : 673.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 892.00 ns  (0.3%)
   LB compute        : 288.48 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1882.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0059824067515377e-17,-7.118719676235674e-17,3.758712091572747e-18)
    sum a = (1.8339236379505407e-16,2.8079101543898586e-17,-8.291583667222307e-17)
    sum e = 2.592001408952686
    sum de = -9.41900637346782e-19
Info: CFL hydro = 0.011082050261769482 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011082050261769482 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9571e+04 |  512 |      1 | 2.616e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.8630043724922 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.933526966968328, dt = 0.011082050261769482 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.90 us    (1.7%)
   patch tree reduce : 957.00 ns  (0.3%)
   gen split merge   : 651.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 867.00 ns  (0.3%)
   LB compute        : 278.60 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3067671944533287e-17,-7.062221901027455e-17,2.6609573919311735e-18)
    sum a = (2.1369624819689293e-18,-8.629815612115621e-17,-1.67963787409825e-17)
    sum e = 2.5920014133439495
    sum de = 1.6872896309305663e-18
Info: CFL hydro = 0.011090979933098388 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011090979933098388 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0156e+04 |  512 |      1 | 2.540e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1570.57725484811 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 14.944609017230098, dt = 0.011090979933098388 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.5%)
   patch tree reduce : 2.07 us    (0.7%)
   gen split merge   : 797.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 791.00 ns  (0.3%)
   LB compute        : 276.37 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1837.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1876242177188967e-17,-7.218834904842985e-17,2.8014699934852948e-18)
    sum a = (1.0663150050438385e-16,-1.0327676214227921e-17,1.3678023557534002e-17)
    sum e = 2.5920014169420225
    sum de = 2.574980159653073e-18
Info: CFL hydro = 0.011100686237796899 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011100686237796899 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9525e+04 |  512 |      1 | 2.622e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1522.5888404050847 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.955699997163196, dt = 0.011100686237796899 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 1130.00 ns (0.4%)
   gen split merge   : 635.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 995.00 ns  (0.3%)
   LB compute        : 292.50 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.385512798240951e-17,-7.178144797309605e-17,3.076640504862116e-18)
    sum a = (-1.534597034408107e-16,1.8383732036664213e-17,-6.120787470614841e-17)
    sum e = 2.5920014195383225
    sum de = 9.147955830346444e-20
Info: CFL hydro = 0.011111019759588068 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011111019759588068 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7953e+04 |  512 |      1 | 2.852e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1401.2773296555292 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.966800683400992, dt = 0.011111019759588068 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.4%)
   patch tree reduce : 1209.00 ns (0.4%)
   gen split merge   : 651.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 953.00 ns  (0.3%)
   LB compute        : 282.93 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1975.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.05779642857462e-17,-7.132770936391086e-17,2.0491421059976032e-18)
    sum a = (1.0143985261154564e-16,-1.6627324517237696e-18,8.064984227326711e-17)
    sum e = 2.5920014209948503
    sum de = 1.7448878713438587e-18
Info: CFL hydro = 0.011121824033164978 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011121824033164978 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0133e+04 |  512 |      1 | 2.543e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1572.8990696782732 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.97791170316058, dt = 0.011121824033164978 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.4%)
   patch tree reduce : 1274.00 ns (0.4%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 277.33 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3127682534780361e-17,-7.149456807825639e-17,3.6504002945414445e-18)
    sum a = (7.03119203485092e-17,9.529096262061998e-17,-1.2625057249637804e-16)
    sum e = 2.592001421253996
    sum de = -1.7448878713438587e-19
Info: CFL hydro = 0.01113293775360003 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01113293775360003 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9785e+04 |  512 |      1 | 2.588e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1547.1834830701935 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 14.989033527193744, dt = 0.010966472806256178 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.4%)
   patch tree reduce : 963.00 ns  (0.3%)
   gen split merge   : 821.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 865.00 ns  (0.3%)
   LB compute        : 277.07 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3698514978593978e-17,-7.007480533338662e-17,1.1299555041643928e-18)
    sum a = (-7.798449386253736e-18,-2.737653853612798e-17,-1.0709109380530046e-16)
    sum e = 2.592001417904257
    sum de = -4.799500437379679e-19
Info: CFL hydro = 0.01114402963691481 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114402963691481 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0247e+04 |  512 |      1 | 2.529e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1561.2028886450469 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 1706                                                    [SPH][rank=0]
Info: time since start : 1797.1459332230002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.1498903278397089 max=0.15010827387120862 delta=0.00021794603149971614
Number of particle pairs: 130816
Distance min=0.126971 max=1.974167 mean=0.800401
---------------- t = 15, dt = 0.01114402963691481 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.85 us    (1.6%)
   patch tree reduce : 1292.00 ns (0.2%)
   gen split merge   : 476.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 839.00 ns  (0.1%)
   LB compute        : 599.76 us  (95.9%)
   LB move op cnt    : 0
   LB apply          : 5.78 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.32 us    (79.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3358942858171519e-17,-7.10305837585412e-17,4.3910187985662926e-20)
    sum a = (3.3441999169880885e-17,1.885210737517795e-17,-1.3399632965704899e-16)
    sum e = 2.592001418399266
    sum de = 3.1001405869507392e-19
Info: CFL hydro = 0.011155269331617817 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011155269331617817 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7334e+04 |  512 |      1 | 2.954e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1358.202592763521 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.011144029636915, dt = 0.011155269331617817 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1182.00 ns (0.4%)
   gen split merge   : 724.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1316.00 ns (0.4%)
   LB compute        : 283.24 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3638504388346905e-17,-7.032948442370345e-17,-1.5280745419010699e-18)
    sum a = (2.221270042901402e-17,4.299685607556114e-17,2.458970527197124e-19)
    sum e = 2.592001415553
    sum de = -1.2874900798265365e-19
Info: CFL hydro = 0.011154522619445904 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011154522619445904 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9495e+04 |  512 |      1 | 2.626e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.0735938406046 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.022299298968532, dt = 0.011154522619445904 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.77 us    (1.6%)
   patch tree reduce : 1352.00 ns (0.5%)
   gen split merge   : 747.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 894.00 ns  (0.3%)
   LB compute        : 274.10 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1961.00 ns (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3764380260572472e-17,-7.006016860405806e-17,-7.142723912334503e-19)
    sum a = (-7.217663966496701e-17,1.340256031157061e-16,-5.400074918476827e-17)
    sum e = 2.5920014119074937
    sum de = 7.301424005332069e-19
Info: CFL hydro = 0.011153952533623113 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011153952533623113 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9307e+04 |  512 |      1 | 2.652e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1514.2537403289205 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.033453821587978, dt = 0.011153952533623113 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1826.00 ns (0.6%)
   gen split merge   : 729.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 280.23 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.260222395188526e-17,-6.793930652435054e-17,-1.6802965269180347e-18)
    sum a = (6.517442835418664e-17,8.958849287421522e-17,-1.2359254245031259e-17)
    sum e = 2.592001407933851
    sum de = 4.404571325722362e-19
Info: CFL hydro = 0.011154477048765592 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011154477048765592 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9276e+04 |  512 |      1 | 2.656e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1511.7224883171295 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.044607774121602, dt = 0.011154477048765592 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.70 us    (1.6%)
   patch tree reduce : 1724.00 ns (0.6%)
   gen split merge   : 729.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 283.40 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4036623426083584e-17,-6.682545142244756e-17,-1.4958737373782505e-18)
    sum a = (-3.5854132163226634e-17,-8.166124026987021e-17,2.865432500651077e-17)
    sum e = 2.5920014039503063
    sum de = 7.521652571618187e-19
Info: CFL hydro = 0.011156104966814056 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011156104966814056 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9414e+04 |  512 |      1 | 2.637e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1522.641909293796 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.055762251170368, dt = 0.011156104966814056 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.11 us    (1.6%)
   patch tree reduce : 1896.00 ns (0.6%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 301.43 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2985706260293384e-17,-6.946152637452019e-17,-9.396780228931867e-19)
    sum a = (-1.262622818798409e-16,-1.0095244952490478e-16,-8.581075303451536e-17)
    sum e = 2.592001400260239
    sum de = -3.3881317890172014e-20
Info: CFL hydro = 0.011158831094112967 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011158831094112967 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9142e+04 |  512 |      1 | 2.675e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1501.5336828164286 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.066918356137181, dt = 0.011158831094112967 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.5%)
   patch tree reduce : 1464.00 ns (0.5%)
   gen split merge   : 689.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1527.00 ns (0.5%)
   LB compute        : 283.44 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1960.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.114147836489554e-17,-7.047877906285472e-17,-2.476534602391389e-18)
    sum a = (2.7634144972310537e-18,-2.2675221075796336e-17,8.157049254803317e-18)
    sum e = 2.592001397143518
    sum de = -1.799097979968134e-18
Info: CFL hydro = 0.011162636610111548 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011162636610111548 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9093e+04 |  512 |      1 | 2.682e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1498.045949766002 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.078077187231294, dt = 0.011162636610111548 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.19 us    (1.7%)
   patch tree reduce : 1488.00 ns (0.5%)
   gen split merge   : 712.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1020.00 ns (0.3%)
   LB compute        : 279.74 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1960.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2031391508071643e-17,-7.018897182214934e-17,-1.93497561723488e-18)
    sum a = (-2.0725608729232902e-17,4.3514996293791965e-17,6.91794034167123e-17)
    sum e = 2.5920013948376623
    sum de = 6.979551485375435e-19
Info: CFL hydro = 0.01116748961705064 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01116748961705064 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9247e+04 |  512 |      1 | 2.660e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.6310622619947 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.089239823841405, dt = 0.01116748961705064 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.5%)
   patch tree reduce : 1205.00 ns (0.4%)
   gen split merge   : 752.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1309.00 ns (0.4%)
   LB compute        : 281.77 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1937.00 ns (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1630345124469255e-17,-6.966351323925424e-17,-8.957678349075238e-19)
    sum a = (5.900358326926813e-17,3.946062226978242e-17,-5.233984632421057e-17)
    sum e = 2.5920013935211514
    sum de = 2.168404344971009e-19
Info: CFL hydro = 0.01117334499249134 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01117334499249134 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7467e+04 |  512 |      1 | 2.931e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1371.5309049967332 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.100407313458456, dt = 0.01117334499249134 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.66 us    (1.5%)
   patch tree reduce : 1394.00 ns (0.5%)
   gen split merge   : 713.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1086.00 ns (0.4%)
   LB compute        : 291.52 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2654916177468057e-17,-6.896095023148363e-17,-2.0842702563861337e-18)
    sum a = (8.123970246520784e-17,-9.703053790131865e-18,4.233673958284334e-17)
    sum e = 2.5920013933034944
    sum de = -1.6940658945086007e-19
Info: CFL hydro = 0.011180145212121888 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011180145212121888 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8809e+04 |  512 |      1 | 2.722e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1477.7019104291403 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.111580658450947, dt = 0.011180145212121888 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.6%)
   patch tree reduce : 1177.00 ns (0.4%)
   gen split merge   : 651.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1297.00 ns (0.4%)
   LB compute        : 273.97 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.36 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1842.00 ns (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3799508410961002e-17,-6.930784071657036e-17,-1.2002118049414534e-18)
    sum a = (-1.2314758587872454e-16,3.391476552719319e-17,6.053897617583348e-17)
    sum e = 2.592001394217924
    sum de = -1.5111067779016718e-18
Info: CFL hydro = 0.01117948632594891 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01117948632594891 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8252e+04 |  512 |      1 | 2.805e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1434.8335896868005 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.12276080366307, dt = 0.01117948632594891 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1528.00 ns (0.5%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 913.00 ns  (0.3%)
   LB compute        : 289.94 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1123914289701275e-17,-6.851892100576129e-17,-3.776276166767012e-19)
    sum a = (-3.3371742869103828e-18,6.7539723813681e-17,-2.1483791308452015e-17)
    sum e = 2.5920013961339996
    sum de = -9.825582188149884e-19
Info: CFL hydro = 0.011178291246016756 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011178291246016756 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8845e+04 |  512 |      1 | 2.717e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1481.3075257183657 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.133940289989019, dt = 0.011178291246016756 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.5%)
   patch tree reduce : 1815.00 ns (0.6%)
   gen split merge   : 683.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1493.00 ns (0.5%)
   LB compute        : 280.22 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1855.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1931861748637473e-17,-6.772121925735507e-17,-9.33823331161765e-19)
    sum a = (-3.3676186839137757e-17,1.167191343576235e-16,-1.0225219108928041e-16)
    sum e = 2.592001398995735
    sum de = 1.6940658945086007e-19
Info: CFL hydro = 0.011176892937889498 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011176892937889498 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8565e+04 |  512 |      1 | 2.758e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1459.1581568364988 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.145118581235035, dt = 0.011176892937889498 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.5%)
   patch tree reduce : 1472.00 ns (0.5%)
   gen split merge   : 892.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 822.00 ns  (0.3%)
   LB compute        : 284.26 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1859.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1197097936344048e-17,-6.607019618909415e-17,-2.6141198580798e-18)
    sum a = (7.716483702013832e-17,3.8160880705406794e-17,-5.1170005732625865e-17)
    sum e = 2.5920014026203253
    sum de = -1.3518645838178633e-18
Info: CFL hydro = 0.011175353121614051 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011175353121614051 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8744e+04 |  512 |      1 | 2.732e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1473.01894298578 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 15.156295474172925, dt = 0.011175353121614051 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.5%)
   patch tree reduce : 2.11 us    (0.7%)
   gen split merge   : 686.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 876.00 ns  (0.3%)
   LB compute        : 286.58 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1964.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2745663899305092e-17,-6.619607206131973e-17,-2.9741833995622356e-18)
    sum a = (1.892236367595501e-17,-1.919167949560041e-16,1.2209959605880006e-16)
    sum e = 2.5920014067731496
    sum de = 5.04831636563563e-19
Info: CFL hydro = 0.011173737964091816 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011173737964091816 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8833e+04 |  512 |      1 | 2.719e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1479.8318039392805 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.167470827294538, dt = 0.011173737964091816 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.05 us    (1.7%)
   patch tree reduce : 1774.00 ns (0.6%)
   gen split merge   : 761.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 287.83 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1966.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2742736553439381e-17,-6.961082101367145e-17,-6.293793611278353e-19)
    sum a = (2.088368540598129e-16,1.6543602425478365e-16,1.5468095554416195e-17)
    sum e = 2.592001411188676
    sum de = 2.0599841277224584e-18
Info: CFL hydro = 0.011172116413954894 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011172116413954894 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9608e+04 |  512 |      1 | 2.611e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1540.524749459541 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.17864456525863, dt = 0.011172116413954894 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.66 us    (1.6%)
   patch tree reduce : 1284.00 ns (0.4%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 881.00 ns  (0.3%)
   LB compute        : 283.25 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1902.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.602429126890126e-17,-6.584918157623298e-17,-1.1094640831044167e-18)
    sum a = (-1.2458784004465428e-17,-6.186067283420193e-17,-4.3318864120789335e-17)
    sum e = 2.592001415588982
    sum de = 4.1674021004911577e-19
Info: CFL hydro = 0.011170558852133118 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011170558852133118 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8651e+04 |  512 |      1 | 2.745e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1465.0759340616921 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.189816681672584, dt = 0.011170558852133118 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1220.00 ns (0.4%)
   gen split merge   : 669.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 744.00 ns  (0.2%)
   LB compute        : 282.59 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4771387238377008e-17,-6.782074901678924e-17,-1.9203388879063254e-18)
    sum a = (2.003475510492514e-17,4.485864804615325e-17,-1.7306468758082615e-17)
    sum e = 2.5920014197032137
    sum de = -6.742382260144231e-19
Info: CFL hydro = 0.011169134320950656 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011169134320950656 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9383e+04 |  512 |      1 | 2.642e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1522.3736069571714 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.200987240524716, dt = 0.011169134320950656 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.3%)
   patch tree reduce : 1980.00 ns (0.6%)
   gen split merge   : 736.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 891.00 ns  (0.3%)
   LB compute        : 300.24 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.39 us    (70.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5228053193427905e-17,-6.676104981340191e-17,-2.0374327225347597e-18)
    sum a = (-6.169088677399071e-17,-1.1646152792144092e-16,-6.35760975115085e-17)
    sum e = 2.5920014232852813
    sum de = -1.2061749168901237e-18
Info: CFL hydro = 0.011167909944644672 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011167909944644672 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9884e+04 |  512 |      1 | 2.575e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1561.5386641425955 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.212156374845668, dt = 0.011167909944644672 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1520.00 ns (0.5%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 830.00 ns  (0.3%)
   LB compute        : 282.48 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4051260155412137e-17,-6.876335438554815e-17,-2.9536919785022596e-18)
    sum a = (7.968235446464966e-17,9.447130577822093e-17,-3.1264053845792004e-18)
    sum e = 2.5920014261338555
    sum de = -1.1350241493207625e-18
Info: CFL hydro = 0.011166949289413834 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011166949289413834 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9909e+04 |  512 |      1 | 2.572e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1563.3415217148 (tsim/hr)                               [sph::Model][rank=0]
---------------- t = 15.223324284790312, dt = 0.011166949289413834 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.68 us    (1.2%)
   patch tree reduce : 1063.00 ns (0.3%)
   gen split merge   : 740.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 932.00 ns  (0.3%)
   LB compute        : 304.91 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5579334697313206e-17,-6.668201147502773e-17,-2.685839831789716e-18)
    sum a = (-1.6303560064490075e-16,-1.6978606021123e-18,-6.682545142244756e-17)
    sum e = 2.592001428099137
    sum de = 1.1519648082658485e-18
Info: CFL hydro = 0.011166314877811228 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011166314877811228 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9911e+04 |  512 |      1 | 2.571e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1563.35081384505 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 15.234491234079726, dt = 0.011166314877811228 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.3%)
   patch tree reduce : 1285.00 ns (0.4%)
   gen split merge   : 730.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1295.00 ns (0.4%)
   LB compute        : 291.81 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2435365237539741e-17,-6.709476724209296e-17,-3.710410884788517e-18)
    sum a = (9.138295588989598e-17,6.512759082033526e-17,-7.551966864360881e-17)
    sum e = 2.5920014290937776
    sum de = -1.6822074332470405e-18
Info: CFL hydro = 0.011166057340618369 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011166057340618369 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9759e+04 |  512 |      1 | 2.591e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1551.340313817491 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.245657548957539, dt = 0.011166057340618369 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.03 us    (1.7%)
   patch tree reduce : 1887.00 ns (0.6%)
   gen split merge   : 849.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 985.00 ns  (0.3%)
   LB compute        : 278.64 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1976.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4929463915125395e-17,-6.59735937755257e-17,-4.622279121957451e-18)
    sum a = (-4.374406110778384e-17,4.570172365547798e-17,8.237551266110365e-17)
    sum e = 2.5920014290977225
    sum de = -1.5380000739769958e-18
Info: CFL hydro = 0.011166220708006467 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011166220708006467 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8729e+04 |  512 |      1 | 2.734e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1470.4118671429449 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.256823606298157, dt = 0.011166220708006467 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.6%)
   patch tree reduce : 1703.00 ns (0.6%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1029.00 ns (0.4%)
   LB compute        : 272.47 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3781944335766738e-17,-6.600872192591422e-17,-2.9053907717180304e-18)
    sum a = (3.803354116024837e-18,4.183762711273964e-17,-7.786740002790892e-18)
    sum e = 2.5920014281559336
    sum de = -7.602120701607346e-20
Info: CFL hydro = 0.0111668407716453 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0111668407716453 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9611e+04 |  512 |      1 | 2.611e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1539.6931333693815 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.267989827006163, dt = 0.0111668407716453 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.4%)
   patch tree reduce : 1558.00 ns (0.5%)
   gen split merge   : 645.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 996.00 ns  (0.3%)
   LB compute        : 276.56 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.41 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.38 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3904892862126594e-17,-6.547594497835485e-17,-3.4528044486059616e-18)
    sum a = (-8.453882125586398e-17,6.712989539248149e-17,6.583015382810587e-17)
    sum e = 2.59200142637255
    sum de = 2.591920818598159e-18
Info: CFL hydro = 0.011166743141475277 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011166743141475277 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9910e+04 |  512 |      1 | 2.572e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1563.3060147114556 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.279156667777809, dt = 0.011166743141475277 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.4%)
   patch tree reduce : 1630.00 ns (0.6%)
   gen split merge   : 665.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1468.00 ns (0.5%)
   LB compute        : 278.93 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.38 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2259724485597089e-17,-6.401519939136513e-17,-2.2833297752544722e-18)
    sum a = (-5.213017517657903e-17,-1.4461088576611658e-17,-7.892124453956483e-17)
    sum e = 2.5920014238948395
    sum de = -7.115076756936123e-19
Info: CFL hydro = 0.011163648526727929 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011163648526727929 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9727e+04 |  512 |      1 | 2.595e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1548.8770548462853 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.290323410919283, dt = 0.011163648526727929 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.5%)
   patch tree reduce : 1455.00 ns (0.5%)
   gen split merge   : 686.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1096.00 ns (0.4%)
   LB compute        : 293.53 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2072374350191595e-17,-6.501049698570682e-17,-3.8919063284625906e-18)
    sum a = (1.4191772756966257e-17,-4.859394137080031e-18,5.2914703868589543e-17)
    sum e = 2.5920014208974984
    sum de = -2.507217523872729e-19
Info: CFL hydro = 0.011162102389890429 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011162102389890429 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9181e+04 |  512 |      1 | 2.669e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1505.6108982434453 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.30148705944601, dt = 0.011162102389890429 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.5%)
   patch tree reduce : 1309.00 ns (0.4%)
   gen split merge   : 680.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 280.70 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.263442475640808e-17,-6.51656463165895e-17,-2.520444790377052e-18)
    sum a = (2.417987685077172e-18,-6.132789588664256e-17,-4.585394564049494e-17)
    sum e = 2.592001417666175
    sum de = -6.420509740187597e-19
Info: CFL hydro = 0.011162103568151904 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011162103568151904 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9622e+04 |  512 |      1 | 2.609e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1539.9869194598405 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.312649161835902, dt = 0.011162103568151904 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.81 us    (1.6%)
   patch tree reduce : 1012.00 ns (0.3%)
   gen split merge   : 612.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1335.00 ns (0.5%)
   LB compute        : 275.82 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1995.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2651988831602346e-17,-6.599115785071996e-17,-3.7177292494527946e-18)
    sum a = (1.2388527703688367e-17,1.979529821310999e-16,-2.3407057542224052e-17)
    sum e = 2.592001414431978
    sum de = 8.216219588366713e-19
Info: CFL hydro = 0.011163633647631274 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011163633647631274 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9556e+04 |  512 |      1 | 2.618e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1534.8459979468525 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.323811265404053, dt = 0.011163633647631274 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.5%)
   patch tree reduce : 1337.00 ns (0.4%)
   gen split merge   : 699.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 966.00 ns  (0.3%)
   LB compute        : 292.65 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1950.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2868612425664948e-17,-6.257201787956967e-17,-3.785058204364145e-18)
    sum a = (2.2741964561534545e-16,1.4089901120839522e-16,-6.199533074402464e-17)
    sum e = 2.5920014114206817
    sum de = -4.743384504624082e-19
Info: CFL hydro = 0.011164115045034744 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011164115045034744 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9467e+04 |  512 |      1 | 2.630e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.031759281649 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.334974899051685, dt = 0.011164115045034744 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.5%)
   patch tree reduce : 1340.00 ns (0.4%)
   gen split merge   : 1068.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1069.00 ns (0.3%)
   LB compute        : 301.29 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.39 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.651315802847497e-17,-6.12312934730741e-17,-4.707903988529494e-18)
    sum a = (9.289053901073707e-17,-9.311887198826252e-18,-8.623960920384199e-17)
    sum e = 2.5920014088095744
    sum de = -3.9302328752599536e-19
Info: CFL hydro = 0.011160154007774052 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011160154007774052 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9457e+04 |  512 |      1 | 2.631e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.3103383144305 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.34613901409672, dt = 0.011160154007774052 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.81 us    (1.6%)
   patch tree reduce : 1140.00 ns (0.4%)
   gen split merge   : 780.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1308.00 ns (0.4%)
   LB compute        : 279.97 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6861512186494566e-17,-6.208607846586167e-17,-5.627822426829132e-18)
    sum a = (1.0948273537758624e-17,-4.2718758218318605e-17,-3.7470027081099033e-19)
    sum e = 2.592001406738513
    sum de = -6.505213034913027e-19
Info: CFL hydro = 0.011156870482130288 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011156870482130288 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9841e+04 |  512 |      1 | 2.580e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1556.9472825446974 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.357299168104493, dt = 0.011156870482130288 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 2.09 us    (0.7%)
   gen split merge   : 745.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 283.25 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.78 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.637264542692085e-17,-6.255738115024112e-17,-5.2714180676788345e-18)
    sum a = (-1.595988965985562e-16,-1.5968671697452752e-18,-1.2084083733654439e-17)
    sum e = 2.5920014053960303
    sum de = 4.641740550953566e-19
Info: CFL hydro = 0.011154311986006662 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011154311986006662 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9131e+04 |  512 |      1 | 2.676e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1500.785698587736 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.368456038586624, dt = 0.011154311986006662 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.49 us    (1.6%)
   patch tree reduce : 1533.00 ns (0.5%)
   gen split merge   : 665.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 933.00 ns  (0.3%)
   LB compute        : 272.37 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3843418598946665e-17,-6.227635594713288e-17,-5.467550240681462e-18)
    sum a = (1.099042731822486e-16,4.418060156000797e-17,-4.255775419570451e-17)
    sum e = 2.592001404859844
    sum de = -2.405573570202213e-19
Info: CFL hydro = 0.011152511267196229 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011152511267196229 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9347e+04 |  512 |      1 | 2.646e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1517.3280210965354 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.37961035057263, dt = 0.011152511267196229 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.3%)
   patch tree reduce : 1908.00 ns (0.6%)
   gen split merge   : 794.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 956.00 ns  (0.3%)
   LB compute        : 288.75 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.636386338932372e-17,-6.173186961611065e-17,-6.239637712762702e-18)
    sum a = (1.7365015675396832e-17,4.8290961073699236e-17,-1.3758525568841051e-16)
    sum e = 2.5920014051538574
    sum de = -9.825582188149884e-20
Info: CFL hydro = 0.011151486020669153 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011151486020669153 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9912e+04 |  512 |      1 | 2.571e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1561.4280700337029 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.390762861839827, dt = 0.011151486020669153 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1767.00 ns (0.6%)
   gen split merge   : 665.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 276.65 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.624091486296386e-17,-6.095612296169728e-17,-8.334153679678824e-18)
    sum a = (8.407337326321595e-18,2.4449192670417118e-17,-3.7472954426964745e-17)
    sum e = 2.5920014062497603
    sum de = -8.707498697774207e-19
Info: CFL hydro = 0.011151239095547941 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011151239095547941 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9533e+04 |  512 |      1 | 2.621e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.5921726005201 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.401914347860496, dt = 0.011151239095547941 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.5%)
   patch tree reduce : 1388.00 ns (0.5%)
   gen split merge   : 634.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 897.00 ns  (0.3%)
   LB compute        : 280.39 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6144312449395404e-17,-6.090635808198019e-17,-8.244137794308214e-18)
    sum a = (4.135754239076306e-17,-5.898016450234244e-17,-8.79374698059543e-18)
    sum e = 2.592001408071775
    sum de = 8.216219588366713e-19
Info: CFL hydro = 0.011151758832194379 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011151758832194379 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9381e+04 |  512 |      1 | 2.642e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1519.6455290316037 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.413065586956044, dt = 0.011151758832194379 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.5%)
   patch tree reduce : 2.04 us    (0.7%)
   gen split merge   : 638.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 944.00 ns  (0.3%)
   LB compute        : 280.28 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.31 us    (70.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7072281088825747e-17,-6.198362136056179e-17,-8.219255354449673e-18)
    sum a = (1.1188315898746915e-16,2.219923463803175e-16,4.197813971429376e-18)
    sum e = 2.5920014105024394
    sum de = -9.368184396632562e-19
Info: CFL hydro = 0.01115301961517447 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115301961517447 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0064e+04 |  512 |      1 | 2.552e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1573.197961258714 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.42421734578824, dt = 0.01115301961517447 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.4%)
   patch tree reduce : 1585.00 ns (0.5%)
   gen split merge   : 787.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 972.00 ns  (0.3%)
   LB compute        : 282.30 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8737940886415227e-17,-5.812245216368917e-17,-7.979212993461381e-18)
    sum a = (2.9624740160993924e-17,-1.0403201737563261e-16,8.617813494066206e-17)
    sum e = 2.5920014133918032
    sum de = 1.0333801956502464e-19
Info: CFL hydro = 0.011154982315298328 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011154982315298328 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9721e+04 |  512 |      1 | 2.596e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1546.5168156321572 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.435370365403413, dt = 0.011154982315298328 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.81 us    (1.6%)
   patch tree reduce : 1387.00 ns (0.5%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1270.00 ns (0.4%)
   LB compute        : 277.00 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8468625066769827e-17,-6.114640044296848e-17,-6.5601820850580415e-18)
    sum a = (-6.175528838303634e-17,-3.495250963658769e-18,-3.307937420076595e-17)
    sum e = 2.5920014165698797
    sum de = -3.1509625637859973e-19
Info: CFL hydro = 0.011157595782960382 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011157595782960382 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9057e+04 |  512 |      1 | 2.687e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1494.6683576991427 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.446525347718712, dt = 0.011157595782960382 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.5%)
   patch tree reduce : 1467.00 ns (0.5%)
   gen split merge   : 786.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1029.00 ns (0.3%)
   LB compute        : 293.39 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.705471701363148e-17,-6.04233460141379e-17,-7.717947374946688e-18)
    sum a = (1.3465790982269965e-18,8.920208321994139e-17,-1.1018273695772434e-16)
    sum e = 2.592001419857381
    sum de = 1.5128008437961804e-18
Info: CFL hydro = 0.011160797379003566 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011160797379003566 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9168e+04 |  512 |      1 | 2.671e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1503.771913623553 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.457682943501672, dt = 0.011160797379003566 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1307.00 ns (0.4%)
   gen split merge   : 769.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1047.00 ns (0.4%)
   LB compute        : 276.17 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.745576339723387e-17,-5.884257924665403e-17,-9.291395777766275e-18)
    sum a = (-1.1756220996694822e-17,7.26333056200179e-17,-1.4930195751591824e-17)
    sum e = 2.5920014230761206
    sum de = 5.149960319306146e-19
Info: CFL hydro = 0.011164514530386657 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011164514530386657 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9552e+04 |  512 |      1 | 2.619e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1534.3397822762138 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.468843740880676, dt = 0.011164514530386657 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.5%)
   patch tree reduce : 1893.00 ns (0.6%)
   gen split merge   : 743.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1331.00 ns (0.4%)
   LB compute        : 284.86 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1986.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7142537389602807e-17,-5.87781776376084e-17,-8.84790287911108e-18)
    sum a = (-2.073263435931061e-16,-7.339441554510273e-17,3.570191017820967e-17)
    sum e = 2.5920014260629456
    sum de = -4.248929021664384e-19
Info: CFL hydro = 0.011168666176936877 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011168666176936877 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8867e+04 |  512 |      1 | 2.714e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1481.082972826173 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.480008255411063, dt = 0.011168666176936877 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.01 us    (1.7%)
   patch tree reduce : 1897.00 ns (0.6%)
   gen split merge   : 847.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 285.12 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.378779902749816e-17,-6.002522697640122e-17,-8.214132499184679e-18)
    sum a = (-3.5210116072770245e-17,-6.256323584197254e-17,-9.11458408747734e-17)
    sum e = 2.5920014286773463
    sum de = 1.6940658945086007e-18
Info: CFL hydro = 0.011173163612669144 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011173163612669144 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9172e+04 |  512 |      1 | 2.671e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1505.5800300932071 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.491176921588, dt = 0.00882307841200003 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.4%)
   patch tree reduce : 1916.00 ns (0.6%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 970.00 ns  (0.3%)
   LB compute        : 291.53 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.465575707668143e-17,-6.053751250290063e-17,-9.740011531686466e-18)
    sum a = (8.341764778929672e-17,3.152166028197456e-17,1.5411012310034834e-17)
    sum e = 2.592001402816506
    sum de = -7.547063560035816e-19
Info: CFL hydro = 0.011176935102980371 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011176935102980371 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9586e+04 |  512 |      1 | 2.614e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1215.0593321846516 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 1751                                                    [SPH][rank=0]
Info: time since start : 1798.9697337720002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14990098403950033 max=0.15010986688927958 delta=0.00020888284977924054
Number of particle pairs: 130816
Distance min=0.127124 max=1.974042 mean=0.800315
---------------- t = 15.5, dt = 0.011176935102980371 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.49 us    (1.3%)
   patch tree reduce : 970.00 ns  (0.1%)
   gen split merge   : 492.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 865.00 ns  (0.1%)
   LB compute        : 723.13 us  (96.7%)
   LB move op cnt    : 0
   LB apply          : 5.78 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 6.09 us    (79.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.451171875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5800349310174376e-17,-5.929924520170493e-17,-9.17137459727213e-18)
    sum a = (-5.777409800566957e-17,-5.124026203340293e-17,-4.8677370727973066e-17)
    sum e = 2.5920014315610924
    sum de = -1.0587911840678754e-19
Info: CFL hydro = 0.011181773567527883 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011181773567527883 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5642e+04 |  512 |      1 | 3.273e-02 | 0.1% |   8.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1229.2765098382633 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.51117693510298, dt = 0.011181773567527883 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.04 us    (1.7%)
   patch tree reduce : 1440.00 ns (0.5%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 971.00 ns  (0.3%)
   LB compute        : 281.46 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1935.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.451171875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4289838843467573e-17,-6.065167899166335e-17,-1.0096415890836763e-17)
    sum a = (-7.435458498905589e-18,-1.1533742710900796e-17,8.114602739750509e-18)
    sum e = 2.5920014329018284
    sum de = -4.895850435129856e-19
Info: CFL hydro = 0.01118672967778447 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01118672967778447 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6969e+04 |  512 |      1 | 3.017e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1334.107866004287 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.522358708670508, dt = 0.01118672967778447 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.75 us    (1.5%)
   patch tree reduce : 1191.00 ns (0.4%)
   gen split merge   : 1054.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 885.00 ns  (0.3%)
   LB compute        : 297.15 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1932.00 ns (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.451171875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.453719956912014e-17,-6.020379507420959e-17,-9.701956035432225e-18)
    sum a = (2.046858776222349e-16,6.190751036805331e-17,1.5280745419010699e-18)
    sum e = 2.5920014333881847
    sum de = -9.097133853511186e-19
Info: CFL hydro = 0.011184594968158703 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011184594968158703 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7714e+04 |  512 |      1 | 2.890e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1393.3119823921704 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.533545438348293, dt = 0.011184594968158703 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.75 us    (1.6%)
   patch tree reduce : 1226.00 ns (0.4%)
   gen split merge   : 790.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1139.00 ns (0.4%)
   LB compute        : 281.46 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1999.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.451171875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.819930924712443e-17,-5.931241825810063e-17,-9.728302148223622e-18)
    sum a = (6.501049698570682e-17,9.95297594341693e-18,3.049343004664362e-17)
    sum e = 2.5920014332136128
    sum de = -1.4399560103323106e-19
Info: CFL hydro = 0.01117899053374156 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01117899053374156 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8727e+04 |  512 |      1 | 2.734e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1472.7090138707003 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.544730033316451, dt = 0.01117899053374156 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.4%)
   patch tree reduce : 1133.00 ns (0.4%)
   gen split merge   : 718.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 999.00 ns  (0.3%)
   LB compute        : 296.85 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.451171875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8076360720764572e-17,-5.948805901004327e-17,-9.14576032094716e-18)
    sum a = (-3.3562020350375033e-17,-8.866345158065058e-17,-1.389764768110896e-16)
    sum e = 2.5920014324875336
    sum de = 3.2864878353466853e-19
Info: CFL hydro = 0.011173627350540546 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011173627350540546 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8362e+04 |  512 |      1 | 2.788e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1443.3153977862364 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.555909023850193, dt = 0.011173627350540546 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.5%)
   patch tree reduce : 1409.00 ns (0.5%)
   gen split merge   : 690.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 983.00 ns  (0.3%)
   LB compute        : 283.49 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.451171875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7195229615185602e-17,-6.142157095434531e-17,-1.1603267175211429e-17)
    sum a = (-7.121939756687957e-17,-3.9179597066674176e-17,1.0374221013492723e-16)
    sum e = 2.5920014313543667
    sum de = -2.574980159653073e-19
Info: CFL hydro = 0.011168572986678263 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011168572986678263 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7529e+04 |  512 |      1 | 2.921e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1377.1347170260497 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.567082651200733, dt = 0.011168572986678263 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.5%)
   patch tree reduce : 1779.00 ns (0.6%)
   gen split merge   : 634.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 968.00 ns  (0.3%)
   LB compute        : 289.65 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.451171875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5838404806428617e-17,-6.125324856706693e-17,-9.088677076565798e-18)
    sum a = (-1.5691699038777352e-16,-1.2915449959516323e-17,-6.732529572901768e-17)
    sum e = 2.5920014299251495
    sum de = -1.2908782116155537e-18
Info: CFL hydro = 0.011163893360565526 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011163893360565526 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8402e+04 |  512 |      1 | 2.782e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1445.1075340236612 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.578251224187412, dt = 0.011163893360565526 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.4%)
   patch tree reduce : 1513.00 ns (0.5%)
   gen split merge   : 742.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 981.00 ns  (0.3%)
   LB compute        : 302.25 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.451171875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3872692057603775e-17,-6.129715875505259e-17,-1.0924122934366509e-17)
    sum a = (2.312895968498152e-17,-1.3622696720672067e-16,-1.6963969291794445e-18)
    sum e = 2.592001428322325
    sum de = -8.368685518872487e-19
Info: CFL hydro = 0.011159651731158298 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011159651731158298 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6231e+04 |  512 |      1 | 3.154e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1274.0650825417551 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.589415117547977, dt = 0.011159651731158298 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1127.00 ns (0.4%)
   gen split merge   : 864.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 968.00 ns  (0.3%)
   LB compute        : 296.71 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1956.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.451171875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4964592065513926e-17,-6.370782807546549e-17,-1.048502105450988e-17)
    sum a = (4.99405204690273e-18,-4.033882602949568e-17,8.412313814293304e-17)
    sum e = 2.5920014266686824
    sum de = -8.097634975751111e-19
Info: CFL hydro = 0.011155907767524141 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011155907767524141 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9247e+04 |  512 |      1 | 2.660e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.2401216954806 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.600574769279136, dt = 0.011155907767524141 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.3%)
   patch tree reduce : 1184.00 ns (0.4%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 730.00 ns  (0.2%)
   LB compute        : 295.36 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.37 us    (70.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.451171875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5189997697173664e-17,-6.374295622585401e-17,-9.01768893932231e-18)
    sum a = (-7.311339034199449e-17,-1.379599559592215e-16,5.172620144711093e-18)
    sum e = 2.5920014250796313
    sum de = -6.606856988583543e-19
Info: CFL hydro = 0.011152716643678645 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011152716643678645 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7229e+04 |  512 |      1 | 2.972e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1351.4623216422826 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.61173067704666, dt = 0.011152716643678645 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.4%)
   patch tree reduce : 1308.00 ns (0.4%)
   gen split merge   : 706.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1001.00 ns (0.3%)
   LB compute        : 299.65 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.451171875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3755598222975341e-17,-6.544520784676488e-17,-9.498505497765319e-18)
    sum a = (1.4349849433714644e-17,-2.0322805938111087e-16,1.4153717260712016e-17)
    sum e = 2.5920014236585462
    sum de = -1.5788694136820158e-18
Info: CFL hydro = 0.011150128018954871 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011150128018954871 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8481e+04 |  512 |      1 | 2.770e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1449.1963798277948 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.622883393690339, dt = 0.011150128018954871 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.5%)
   patch tree reduce : 1322.00 ns (0.4%)
   gen split merge   : 745.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1227.00 ns (0.4%)
   LB compute        : 302.98 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1974.00 ns (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.451171875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4610383215762913e-17,-6.803371342851971e-17,-9.385070845469023e-18)
    sum a = (-7.657936784699615e-18,-3.2118838838579574e-17,3.722413002837932e-17)
    sum e = 2.5920014224891466
    sum de = 8.029872339970767e-19
Info: CFL hydro = 0.011148185850925446 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011148185850925446 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7624e+04 |  512 |      1 | 2.905e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1381.673956510385 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.634033521709293, dt = 0.011148185850925446 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.5%)
   patch tree reduce : 1221.00 ns (0.4%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1349.00 ns (0.4%)
   LB compute        : 286.45 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.34 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1945.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.451171875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4070287903539257e-17,-6.751630504675532e-17,-8.779842087733302e-18)
    sum a = (6.321310662416035e-17,-7.353492814665685e-17,6.592382889580861e-18)
    sum e = 2.5920014216322635
    sum de = -5.742883382384156e-19
Info: CFL hydro = 0.011146927227297397 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011146927227297397 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9368e+04 |  512 |      1 | 2.644e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.178323185213 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.64518170756022, dt = 0.011146927227297397 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.87 us    (1.7%)
   patch tree reduce : 1180.00 ns (0.4%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1231.00 ns (0.4%)
   LB compute        : 276.02 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1973.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.451171875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5465168208550483e-17,-6.859795934413548e-17,-8.848268797344293e-18)
    sum a = (1.4859207614348335e-17,3.739391608859055e-17,5.342991674095465e-17)
    sum e = 2.592001421124493
    sum de = -6.818615225397118e-19
Info: CFL hydro = 0.011146381877254806 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011146381877254806 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8700e+04 |  512 |      1 | 2.738e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1465.6115451855333 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.656328634787517, dt = 0.011146381877254806 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.3%)
   patch tree reduce : 1298.00 ns (0.4%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1355.00 ns (0.4%)
   LB compute        : 295.07 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.46 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.451171875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5293918475406398e-17,-6.737945162753333e-17,-7.997874823355289e-18)
    sum a = (2.1691632864917486e-17,2.827230637103551e-17,1.2025536816340222e-16)
    sum e = 2.592001420978971
    sum de = -4.734914175151539e-19
Info: CFL hydro = 0.011146571914697864 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011146571914697864 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8309e+04 |  512 |      1 | 2.796e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1434.9396329816864 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.667475016664772, dt = 0.011146571914697864 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.5%)
   patch tree reduce : 2.26 us    (0.8%)
   gen split merge   : 798.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 999.00 ns  (0.3%)
   LB compute        : 273.94 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.451171875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.551786043413328e-17,-6.757412012760311e-17,-6.222439555801651e-18)
    sum a = (6.397421654924518e-17,-5.1609107612482496e-17,5.845324224651449e-17)
    sum e = 2.592001421186005
    sum de = 2.966732897758187e-19
Info: CFL hydro = 0.011147511958058642 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011147511958058642 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.3806e+04 |  512 |      1 | 3.709e-02 | 0.0% |   1.4% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1082.021557804821 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.67862158857947, dt = 0.011147511958058642 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.00 us    (1.6%)
   patch tree reduce : 1836.00 ns (0.6%)
   gen split merge   : 907.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 969.00 ns  (0.3%)
   LB compute        : 299.57 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.650730333674355e-17,-6.867260666371111e-17,-5.892381309442751e-18)
    sum a = (4.5906637866077736e-17,2.5830899919032645e-17,-2.3172869872967183e-17)
    sum e = 2.5920014217166396
    sum de = 6.212986668110293e-19
Info: CFL hydro = 0.011149208552796377 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011149208552796377 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8464e+04 |  512 |      1 | 2.773e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1447.2636338395957 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.689769100537529, dt = 0.011149208552796377 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.5%)
   patch tree reduce : 1799.00 ns (0.6%)
   gen split merge   : 739.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1000.00 ns (0.3%)
   LB compute        : 297.44 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (68.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7043007630168637e-17,-6.759387971219666e-17,-6.6403181781318764e-18)
    sum a = (-1.0403787206736403e-17,7.373984235725661e-17,-1.2558313763899597e-16)
    sum e = 2.592001422525208
    sum de = 8.843023969334896e-19
Info: CFL hydro = 0.011151658720791007 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011151658720791007 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8219e+04 |  512 |      1 | 2.810e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1428.2179097883977 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.700918309090325, dt = 0.011151658720791007 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.5%)
   patch tree reduce : 1356.00 ns (0.4%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 913.00 ns  (0.3%)
   LB compute        : 286.26 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6627324517237694e-17,-6.642184361121267e-17,-8.600359194341906e-18)
    sum a = (4.278608717322996e-17,6.393030636125952e-17,-7.290262143966331e-17)
    sum e = 2.5920014235529036
    sum de = -5.522654816098038e-19
Info: CFL hydro = 0.011154851283566292 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011154851283566292 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7530e+04 |  512 |      1 | 2.921e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1374.5031098847517 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.712069967811116, dt = 0.011154851283566292 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1374.00 ns (0.4%)
   gen split merge   : 1138.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 983.00 ns  (0.3%)
   LB compute        : 301.99 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.51 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1958.00 ns (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7051789667765772e-17,-6.593297685163896e-17,-9.147406952996624e-18)
    sum a = (-9.12804987845961e-17,2.1173492646686664e-17,1.0749214018890286e-17)
    sum e = 2.592001424734484
    sum de = -6.047815243395704e-19
Info: CFL hydro = 0.011158766884680092 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011158766884680092 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.3576e+04 |  512 |      1 | 3.771e-02 | 0.0% |   1.4% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1064.817813597406 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.723224819094682, dt = 0.011158766884680092 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.6%)
   patch tree reduce : 1305.00 ns (0.4%)
   gen split merge   : 641.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1652.00 ns (0.5%)
   LB compute        : 283.55 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1911.00 ns (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5339292336324916e-17,-6.570372907853047e-17,-8.610421945755286e-18)
    sum a = (2.787418733329883e-17,-8.407776428201452e-17,7.095886378483129e-18)
    sum e = 2.5920014260015765
    sum de = -9.41900637346782e-19
Info: CFL hydro = 0.011163378434261455 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011163378434261455 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7811e+04 |  512 |      1 | 2.875e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1397.448219714168 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.734383585979362, dt = 0.011163378434261455 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.6%)
   patch tree reduce : 1150.00 ns (0.4%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 991.00 ns  (0.3%)
   LB compute        : 276.94 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1971.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.458984375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6349226659995163e-17,-6.718148986336464e-17,-8.645184177910604e-18)
    sum a = (-1.1700015956073173e-16,-8.78350127006544e-18,8.442465476710125e-17)
    sum e = 2.59200142728832
    sum de = 1.4230153513872246e-19
Info: CFL hydro = 0.01116865040593008 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01116865040593008 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9295e+04 |  512 |      1 | 2.654e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1514.4780533594435 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.745546964413624, dt = 0.01116865040593008 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.4%)
   patch tree reduce : 1436.00 ns (0.5%)
   gen split merge   : 841.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 888.00 ns  (0.3%)
   LB compute        : 276.18 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.57 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1792.00 ns (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4118589110323488e-17,-6.717618404898304e-17,-7.202368584348362e-18)
    sum a = (5.929631785583922e-17,1.8140250044283712e-16,-1.2319442341257592e-16)
    sum e = 2.5920014285341124
    sum de = 5.21772295508649e-19
Info: CFL hydro = 0.011174164858666789 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011174164858666789 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7941e+04 |  512 |      1 | 2.854e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1408.8767388512392 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.756715614819553, dt = 0.011174164858666789 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.6%)
   patch tree reduce : 1419.00 ns (0.5%)
   gen split merge   : 807.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 972.00 ns  (0.3%)
   LB compute        : 279.41 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.36 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1869.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5778394216181546e-17,-6.391127861313239e-17,-9.678171350273324e-18)
    sum a = (-7.143309381507646e-17,-2.237662036254904e-17,1.0215266132984624e-16)
    sum e = 2.5920014296834872
    sum de = -8.300922883092143e-19
Info: CFL hydro = 0.011179044141078539 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011179044141078539 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7966e+04 |  512 |      1 | 2.850e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1411.5411107493937 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.767889779678221, dt = 0.011179044141078539 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1234.00 ns (0.4%)
   gen split merge   : 754.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1333.00 ns (0.4%)
   LB compute        : 293.94 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3802435756826713e-17,-6.54457567241147e-17,-7.257622237563655e-18)
    sum a = (5.647435644129395e-17,-2.2221482466611153e-17,-1.100682045507284e-18)
    sum e = 2.592001430684586
    sum de = -9.147955830346444e-19
Info: CFL hydro = 0.011179493915542729 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011179493915542729 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8336e+04 |  512 |      1 | 2.792e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1441.266842777453 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.7790688238193, dt = 0.011179493915542729 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.71 us    (1.5%)
   patch tree reduce : 1227.00 ns (0.4%)
   gen split merge   : 737.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 936.00 ns  (0.3%)
   LB compute        : 294.08 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.42 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5304164185936387e-17,-6.547301763248913e-17,-7.909688529150748e-18)
    sum a = (-6.308430340606908e-17,-5.619625858405141e-17,-1.1813596975662755e-16)
    sum e = 2.592001431464887
    sum de = -4.607859233063394e-19
Info: CFL hydro = 0.011178965271440943 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011178965271440943 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8501e+04 |  512 |      1 | 2.767e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1454.261502709296 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.790248317734843, dt = 0.011178965271440943 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.5%)
   patch tree reduce : 2.26 us    (0.8%)
   gen split merge   : 808.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1064.00 ns (0.4%)
   LB compute        : 277.81 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.72 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4013204659157896e-17,-6.640281586308555e-17,-9.887842497904863e-18)
    sum a = (-1.0673395760968374e-16,1.4182990719369126e-17,7.657936784699615e-18)
    sum e = 2.592001432050635
    sum de = 2.541098841762901e-19
Info: CFL hydro = 0.011179220759546353 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011179220759546353 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8600e+04 |  512 |      1 | 2.753e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1462.0014801987193 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.801427283006284, dt = 0.011179220759546353 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.78 us    (1.6%)
   patch tree reduce : 1366.00 ns (0.5%)
   gen split merge   : 714.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1097.00 ns (0.4%)
   LB compute        : 282.41 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1975.00 ns (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2570023147362442e-17,-6.56726260287073e-17,-9.063794636707256e-18)
    sum a = (-1.0356803305591744e-16,6.272423986458664e-17,-5.076017731142635e-17)
    sum e = 2.592001432463799
    sum de = -1.378969638130001e-18
Info: CFL hydro = 0.01117919043120547 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01117919043120547 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9039e+04 |  512 |      1 | 2.689e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1496.5632660689516 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.81260650376583, dt = 0.01117919043120547 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.5%)
   patch tree reduce : 1310.00 ns (0.4%)
   gen split merge   : 700.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1254.00 ns (0.4%)
   LB compute        : 276.01 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1911.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1524960673303663e-17,-6.520754395429248e-17,-9.926629830625533e-18)
    sum a = (-8.448814158056386e-17,7.335343270298278e-17,-8.805456364058272e-18)
    sum e = 2.5920014327044836
    sum de = 9.825582188149884e-20
Info: CFL hydro = 0.011176519695187926 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011176519695187926 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8985e+04 |  512 |      1 | 2.697e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1492.293100364041 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.823785694197035, dt = 0.011176519695187926 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.3%)
   patch tree reduce : 1133.00 ns (0.4%)
   gen split merge   : 1052.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1007.00 ns (0.3%)
   LB compute        : 289.45 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.44 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (69.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0591137342141898e-17,-6.39615923701993e-17,-9.797826612534255e-18)
    sum a = (1.767604617362861e-17,-1.468795788120425e-17,-3.443729676422258e-17)
    sum e = 2.592001432766686
    sum de = 4.70950318673391e-19
Info: CFL hydro = 0.011174330529998978 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011174330529998978 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9360e+04 |  512 |      1 | 2.645e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1521.3788337816384 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.834962213892222, dt = 0.011174330529998978 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 1461.00 ns (0.5%)
   gen split merge   : 725.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 984.00 ns  (0.3%)
   LB compute        : 280.48 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.137859338001812e-17,-6.473532647433e-17,-1.0434524338326368e-17)
    sum a = (-7.843823247172255e-17,-1.5624708558231727e-17,-7.9020774298999e-17)
    sum e = 2.592001432718343
    sum de = 2.439454888092385e-19
Info: CFL hydro = 0.011172684182790268 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011172684182790268 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9034e+04 |  512 |      1 | 2.690e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1495.4593345634898 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.84613654442222, dt = 0.011172684182790268 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.4%)
   patch tree reduce : 1219.00 ns (0.4%)
   gen split merge   : 751.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1311.00 ns (0.4%)
   LB compute        : 308.70 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.462890625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0207655033733776e-17,-6.48988919245766e-17,-1.1646445526730664e-17)
    sum a = (1.035987701875074e-17,-9.345405308988641e-17,1.3602790768785233e-16)
    sum e = 2.592001432596013
    sum de = 8.267041565201971e-19
Info: CFL hydro = 0.011171631584228221 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011171631584228221 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8976e+04 |  512 |      1 | 2.698e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1490.6941855044013 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.857309228605011, dt = 0.011171631584228221 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 1236.00 ns (0.4%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1222.00 ns (0.4%)
   LB compute        : 284.55 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1930.00 ns (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.462890625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0857525815921587e-17,-6.646904706329726e-17,-8.792283307662574e-18)
    sum a = (-8.047859254012302e-17,-4.7437639753844515e-17,-4.1217029789208933e-17)
    sum e = 2.5920014324376432
    sum de = -1.9651164376299768e-19
Info: CFL hydro = 0.011171213518015186 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011171213518015186 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9160e+04 |  512 |      1 | 2.672e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1505.0233541013433 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.868480860189239, dt = 0.011171213518015186 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.5%)
   patch tree reduce : 2.07 us    (0.7%)
   gen split merge   : 815.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1017.00 ns (0.3%)
   LB compute        : 293.52 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1937.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.462890625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.279686394303433e-18,-6.661212109248388e-17,-1.030572112023509e-17)
    sum a = (-6.661468252011638e-17,4.113579594143546e-17,5.2815174109155373e-17)
    sum e = 2.5920014322819616
    sum de = -6.945670167485263e-19
Info: CFL hydro = 0.011171458883133208 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011171458883133208 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9425e+04 |  512 |      1 | 2.636e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1525.767893998447 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.879652073707254, dt = 0.011171458883133208 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1544.00 ns (0.5%)
   gen split merge   : 691.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1374.00 ns (0.5%)
   LB compute        : 281.14 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.462890625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.585905424129958e-18,-6.595932296443036e-17,-9.240167225116335e-18)
    sum a = (1.516482252272855e-16,1.3411781451047599e-16,-2.837183613046967e-17)
    sum e = 2.5920014321660276
    sum de = 8.436448154652831e-19
Info: CFL hydro = 0.011172385188633952 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011172385188633952 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9216e+04 |  512 |      1 | 2.664e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.3989201573074 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.890823532590387, dt = 0.011172385188633952 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.5%)
   patch tree reduce : 1765.00 ns (0.6%)
   gen split merge   : 794.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 990.00 ns  (0.3%)
   LB compute        : 282.71 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.137859338001812e-17,-6.355194690811638e-17,-9.972003691544051e-18)
    sum a = (-4.294416384997834e-17,1.0715659316904574e-16,-1.229485263598562e-19)
    sum e = 2.592001432121653
    sum de = 1.4568966692773966e-19
Info: CFL hydro = 0.011173997543478335 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011173997543478335 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9003e+04 |  512 |      1 | 2.694e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1492.780613667971 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.90199591777902, dt = 0.011173997543478335 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.59 us    (1.6%)
   patch tree reduce : 2.12 us    (0.7%)
   gen split merge   : 1118.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 1041.00 ns (0.4%)
   LB compute        : 277.38 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.31 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.961757981014063e-18,-6.271179864465737e-17,-9.71293358242864e-18)
    sum a = (-4.5127963865798645e-17,1.5751910884052694e-17,-2.5362524580518908e-17)
    sum e = 2.5920014321759486
    sum de = 7.403067959002585e-19
Info: CFL hydro = 0.011176288958995823 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011176288958995823 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8987e+04 |  512 |      1 | 2.697e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1491.7353177351984 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.913169915322499, dt = 0.011176288958995823 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.4%)
   patch tree reduce : 1388.00 ns (0.4%)
   gen split merge   : 779.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 986.00 ns  (0.3%)
   LB compute        : 292.85 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.431908379320397e-18,-6.269862558826166e-17,-1.0185699939740944e-17)
    sum a = (-4.296172792517261e-17,3.793584099198027e-17,-1.3193547816758854e-17)
    sum e = 2.59200143235065
    sum de = 1.1926223897340549e-18
Info: CFL hydro = 0.01117924090858851 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01117924090858851 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8965e+04 |  512 |      1 | 2.700e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1490.2938445104196 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.924346204281495, dt = 0.01117924090858851 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.4%)
   patch tree reduce : 2.19 us    (0.7%)
   gen split merge   : 777.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1012.00 ns (0.3%)
   LB compute        : 281.26 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1877.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.855221243775357e-18,-6.22189067845183e-17,-1.0337921924757909e-17)
    sum a = (8.950652718997532e-17,5.943683045739334e-17,7.575971100459711e-18)
    sum e = 2.592001432659817
    sum de = 4.603624068327122e-19
Info: CFL hydro = 0.011182822729991144 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011182822729991144 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8630e+04 |  512 |      1 | 2.748e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1464.4247140021955 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.935525445190084, dt = 0.011182822729991144 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.91 us    (1.7%)
   patch tree reduce : 1699.00 ns (0.6%)
   gen split merge   : 912.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 998.00 ns  (0.3%)
   LB compute        : 278.20 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1847.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0418423936064958e-17,-6.219329250819334e-17,-1.0157890154016691e-17)
    sum a = (-4.0807201368009415e-17,-3.877562333720608e-17,2.5362524580518908e-17)
    sum e = 2.5920014331099908
    sum de = 2.4267493938835705e-19
Info: CFL hydro = 0.011185337418262093 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011185337418262093 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8366e+04 |  512 |      1 | 2.788e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1444.1062610843844 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.946708267920075, dt = 0.011185337418262093 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.72 us    (1.5%)
   patch tree reduce : 1288.00 ns (0.4%)
   gen split merge   : 747.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1356.00 ns (0.4%)
   LB compute        : 287.71 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.382143499603312e-18,-6.271216456289059e-17,-9.674878086174399e-18)
    sum a = (6.649758868548794e-17,-7.13525918037694e-17,-1.8274271027681723e-17)
    sum e = 2.5920014336829933
    sum de = 1.3459353531870832e-18
Info: CFL hydro = 0.011183723605659121 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011183723605659121 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8981e+04 |  512 |      1 | 2.697e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1492.7765564761783 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.957893605338336, dt = 0.011183723605659121 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.5%)
   patch tree reduce : 1080.00 ns (0.4%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1246.00 ns (0.4%)
   LB compute        : 289.50 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0856062142988731e-17,-6.356365629157923e-17,-1.002323224419399e-17)
    sum a = (1.175622099669482e-16,-3.4740277061323656e-17,-1.408851063155331e-16)
    sum e = 2.5920014343369493
    sum de = -1.9142944607947188e-19
Info: CFL hydro = 0.011183007617510475 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011183007617510475 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9775e+04 |  512 |      1 | 2.589e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1555.004970758462 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 15.969077328943996, dt = 0.011183007617510475 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.5%)
   patch tree reduce : 1153.00 ns (0.4%)
   gen split merge   : 899.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 907.00 ns  (0.3%)
   LB compute        : 277.92 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.73 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1807.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2417801162345476e-17,-6.387578454451065e-17,-1.2492448481921103e-17)
    sum a = (-1.4670686540596557e-16,1.0650562463215829e-16,-6.732456389255126e-17)
    sum e = 2.592001435113507
    sum de = -8.131516293641283e-20
Info: CFL hydro = 0.011183201044008745 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011183201044008745 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9364e+04 |  512 |      1 | 2.644e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1522.5655024048124 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.980260336561507, dt = 0.011183201044008745 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.4%)
   patch tree reduce : 1253.00 ns (0.4%)
   gen split merge   : 784.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1048.00 ns (0.3%)
   LB compute        : 294.88 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.63 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.159665213809288e-18,-6.147279950699524e-17,-1.2706144730117996e-17)
    sum a = (-1.9920003146989274e-16,3.172364714670861e-17,2.0012800010932307e-17)
    sum e = 2.5920014359934838
    sum de = 1.1180834903756764e-18
Info: CFL hydro = 0.011184302509826117 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011184302509826117 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9437e+04 |  512 |      1 | 2.634e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.3530210168672 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 15.991443537605516, dt = 0.008556462394484043 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.5%)
   patch tree reduce : 1324.00 ns (0.5%)
   gen split merge   : 688.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1228.00 ns (0.4%)
   LB compute        : 272.73 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.19834348378301e-18,-6.20708928591833e-17,-1.2029927835138788e-17)
    sum a = (-2.3922270414589165e-17,-4.9480927168110697e-17,1.7922675062814753e-17)
    sum e = 2.592001410276216
    sum de = -8.809142651444724e-20
Info: CFL hydro = 0.011185079292558893 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011185079292558893 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9516e+04 |  512 |      1 | 2.623e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1174.1335534527707 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 1796                                                    [SPH][rank=0]
Info: time since start : 1801.0536960380002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.1498945197346637 max=0.1501105943453145 delta=0.00021607461065081823
Number of particle pairs: 130816
Distance min=0.126761 max=1.974708 mean=0.800382
---------------- t = 16, dt = 0.011185079292558893 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.25 us    (1.7%)
   patch tree reduce : 1647.00 ns (0.3%)
   gen split merge   : 500.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 752.00 ns  (0.1%)
   LB compute        : 524.55 us  (95.8%)
   LB move op cnt    : 0
   LB apply          : 4.54 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.91 us    (78.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.852605284769387e-18,-6.29267756066705e-17,-1.1972844590757425e-17)
    sum a = (6.526810342188937e-17,-2.0400966072725567e-16,-7.862850995299376e-18)
    sum e = 2.592001437273091
    sum de = 4.641740550953566e-19
Info: CFL hydro = 0.011179312883668505 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011179312883668505 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5581e+04 |  512 |      1 | 3.286e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1225.3397916618208 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.01118507929256, dt = 0.011179312883668505 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.4%)
   patch tree reduce : 1241.00 ns (0.4%)
   gen split merge   : 673.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 969.00 ns  (0.3%)
   LB compute        : 301.79 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.34 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.04988974384513e-18,-6.610184811626715e-17,-1.221142327881286e-17)
    sum a = (-1.4685908739098253e-16,1.7002024788048687e-17,1.7921211389881898e-17)
    sum e = 2.592001438390836
    sum de = -6.844026213814747e-19
Info: CFL hydro = 0.011173977907517844 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011173977907517844 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9119e+04 |  512 |      1 | 2.678e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1502.8744644488154 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.02236439217623, dt = 0.011173977907517844 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.94 us    (1.3%)
   patch tree reduce : 1133.00 ns (0.4%)
   gen split merge   : 661.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 843.00 ns  (0.3%)
   LB compute        : 295.30 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.210364254105593e-18,-6.458914214016106e-17,-1.1829404643337593e-17)
    sum a = (5.4963845974587144e-17,8.351132285699947e-17,1.5358320084452036e-17)
    sum e = 2.5920014392931994
    sum de = -2.202285662861181e-18
Info: CFL hydro = 0.011169073096332265 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011169073096332265 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9154e+04 |  512 |      1 | 2.673e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1504.8634192660722 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.033538370083747, dt = 0.011169073096332265 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.6%)
   patch tree reduce : 1470.00 ns (0.5%)
   gen split merge   : 651.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1053.00 ns (0.4%)
   LB compute        : 275.74 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1931.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.91554322088217e-18,-6.325537018009655e-17,-1.1647909199663519e-17)
    sum a = (1.247517714131341e-16,-7.044657825833189e-17,-6.999283964914671e-18)
    sum e = 2.5920014401501628
    sum de = 8.199278929421627e-19
Info: CFL hydro = 0.011164648345606069 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011164648345606069 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9054e+04 |  512 |      1 | 2.687e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1496.372883169367 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.04470744318008, dt = 0.011164648345606069 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 1156.00 ns (0.4%)
   gen split merge   : 621.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1529.00 ns (0.5%)
   LB compute        : 285.72 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1738.00 ns (62.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.730497657622906e-18,-6.488672514332224e-17,-1.17503663049634e-17)
    sum a = (1.8816979224789422e-17,-3.4381677192774075e-17,-7.330659516913141e-17)
    sum e = 2.5920014409252987
    sum de = 6.098637220230962e-20
Info: CFL hydro = 0.01116074517750698 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01116074517750698 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8742e+04 |  512 |      1 | 2.732e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1471.3123507805606 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.055872091525686, dt = 0.01116074517750698 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 1236.00 ns (0.4%)
   gen split merge   : 817.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 976.00 ns  (0.3%)
   LB compute        : 268.99 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1931.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.483868768436764e-18,-6.53322305922601e-17,-1.2853975696336395e-17)
    sum a = (1.5632026922896004e-17,3.219787717695377e-17,-7.621784063258086e-17)
    sum e = 2.5920014415866977
    sum de = -4.472333961502706e-19
Info: CFL hydro = 0.011157399003594895 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011157399003594895 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9186e+04 |  512 |      1 | 2.669e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1505.5740531781516 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.06703283670319, dt = 0.011157399003594895 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1346.00 ns (0.5%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1004.00 ns (0.3%)
   LB compute        : 282.46 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1905.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.60388994893091e-18,-6.449962939236112e-17,-1.3796581065095293e-17)
    sum a = (-4.3195915594429477e-17,8.875712664835334e-18,1.2505255620083589e-17)
    sum e = 2.5920014421079496
    sum de = 7.386127300057499e-19
Info: CFL hydro = 0.011154638790498833 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011154638790498833 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9625e+04 |  512 |      1 | 2.609e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1539.611141958615 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.078190235706785, dt = 0.011154638790498833 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.3%)
   patch tree reduce : 1571.00 ns (0.5%)
   gen split merge   : 667.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 957.00 ns  (0.3%)
   LB compute        : 290.66 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.72 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.69421722116126e-18,-6.464544780829684e-17,-1.3079381327996131e-17)
    sum a = (-7.602902682424251e-17,-4.687558934762803e-17,2.546424984935236e-17)
    sum e = 2.5920014424680113
    sum de = 3.1848438816761693e-19
Info: CFL hydro = 0.011152485756136536 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011152485756136536 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9167e+04 |  512 |      1 | 2.671e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1503.3057905200994 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.089344874497282, dt = 0.011152485756136536 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1499.00 ns (0.5%)
   gen split merge   : 716.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1468.00 ns (0.5%)
   LB compute        : 279.86 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (64.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.632322508374644e-18,-6.555580663275377e-17,-1.2899349557254913e-17)
    sum a = (2.8863630235909096e-17,-8.650014298589026e-17,7.365055830835243e-17)
    sum e = 2.5920014426522098
    sum de = -3.4558944247975454e-19
Info: CFL hydro = 0.011150952970472559 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011150952970472559 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9308e+04 |  512 |      1 | 2.652e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1514.0555634887849 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.100497360253417, dt = 0.011150952970472559 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.4%)
   patch tree reduce : 1739.00 ns (0.6%)
   gen split merge   : 1117.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 997.00 ns  (0.3%)
   LB compute        : 277.97 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.480520972964366e-18,-6.681291872295998e-17,-1.1658154910193508e-17)
    sum a = (2.567282324228426e-17,9.118682371689335e-17,9.162299825088427e-17)
    sum e = 2.592001442653331
    sum de = 5.488773498207866e-19
Info: CFL hydro = 0.011150045845545532 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011150045845545532 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9318e+04 |  512 |      1 | 2.650e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1514.6353639736624 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.11164831322389, dt = 0.011150045845545532 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.4%)
   patch tree reduce : 1519.00 ns (0.5%)
   gen split merge   : 752.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1169.00 ns (0.4%)
   LB compute        : 289.25 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.773255559535453e-18,-6.462628284083227e-17,-1.0655538951187538e-17)
    sum a = (1.6211641404306755e-17,-1.315754146261061e-16,-5.892747227675965e-18)
    sum e = 2.592001442472616
    sum de = 4.0657581468206416e-19
Info: CFL hydro = 0.011149724861988487 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011149724861988487 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9508e+04 |  512 |      1 | 2.625e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.4303849307419 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.122798359069435, dt = 0.011149724861988487 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1109.00 ns (0.4%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1326.00 ns (0.5%)
   LB compute        : 276.49 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1911.00 ns (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.856684916708213e-18,-6.761254154209057e-17,-1.1305409733375349e-17)
    sum a = (7.208296459726426e-17,-1.8768678018005192e-16,-1.6502034114185272e-16)
    sum e = 2.5920014421204223
    sum de = 6.166399856011306e-19
Info: CFL hydro = 0.011146458912469322 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011146458912469322 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9443e+04 |  512 |      1 | 2.633e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1524.2660871917117 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.133948083931422, dt = 0.011146458912469322 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.3%)
   patch tree reduce : 1555.00 ns (0.5%)
   gen split merge   : 675.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 913.00 ns  (0.3%)
   LB compute        : 289.49 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0089097526172485e-17,-6.996301731313977e-17,-1.4042478117815005e-17)
    sum a = (-3.7235839411842164e-17,6.458603183517875e-17,1.2691800735376014e-16)
    sum e = 2.5920014415768433
    sum de = 7.521652571618187e-19
Info: CFL hydro = 0.011142450007892563 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011142450007892563 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9524e+04 |  512 |      1 | 2.622e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1530.2021143361408 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.145094542843893, dt = 0.011142450007892563 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1021.00 ns (0.4%)
   gen split merge   : 709.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1177.00 ns (0.4%)
   LB compute        : 275.53 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1878.00 ns (64.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.035253014516575e-18,-6.766267234004086e-17,-1.0924854770832936e-17)
    sum a = (-1.3658995809406882e-17,-1.3594301465774673e-16,-5.2048209492339126e-17)
    sum e = 2.592001440899535
    sum de = 5.759824041329242e-19
Info: CFL hydro = 0.011138972201468368 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011138972201468368 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9721e+04 |  512 |      1 | 2.596e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1545.0528631469529 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.156236992851785, dt = 0.011138972201468368 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.4%)
   patch tree reduce : 1238.00 ns (0.4%)
   gen split merge   : 733.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 803.00 ns  (0.3%)
   LB compute        : 275.21 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (63.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.046596479746204e-18,-7.036900359289055e-17,-1.2546604380436754e-17)
    sum a = (3.409479729793441e-17,-1.203578252687021e-16,1.4072337045645255e-16)
    sum e = 2.5920014401435014
    sum de = -1.1045309632196076e-18
Info: CFL hydro = 0.011136069497064497 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011136069497064497 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8359e+04 |  512 |      1 | 2.789e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1437.8659534314243 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.167375965053253, dt = 0.011136069497064497 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.4%)
   patch tree reduce : 1443.00 ns (0.5%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 947.00 ns  (0.3%)
   LB compute        : 295.52 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.65 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.560345679178461e-18,-7.141699341281505e-17,-1.0007131841932581e-17)
    sum a = (2.755071561513778e-16,-1.0772340051229401e-16,6.535006910612929e-17)
    sum e = 2.5920014393570137
    sum de = 1.1248597539537109e-18
Info: CFL hydro = 0.011133777648136082 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011133777648136082 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8687e+04 |  512 |      1 | 2.740e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1463.2345769583671 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.178512034550316, dt = 0.011133777648136082 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.97 us    (1.7%)
   patch tree reduce : 1412.00 ns (0.5%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 988.00 ns  (0.3%)
   LB compute        : 281.38 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.55 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4158657156860405e-17,-7.271710089542388e-17,-9.695369507234374e-18)
    sum a = (1.0653782543668111e-16,-8.327420784187689e-17,-9.191866018332107e-18)
    sum e = 2.592001438593055
    sum de = -5.996993266560446e-19
Info: CFL hydro = 0.01113212320694994 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01113212320694994 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9301e+04 |  512 |      1 | 2.653e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.9332099286626 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.189645812198453, dt = 0.01113212320694994 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.5%)
   patch tree reduce : 1307.00 ns (0.4%)
   gen split merge   : 721.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1258.00 ns (0.4%)
   LB compute        : 275.11 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4458893067212374e-17,-7.344966919831802e-17,-1.0125689349493872e-17)
    sum a = (1.125418118072541e-16,-1.674734569773184e-17,-7.4383858447713e-17)
    sum e = 2.592001437904721
    sum de = 5.72594272343907e-19
Info: CFL hydro = 0.011131123074244638 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011131123074244638 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8102e+04 |  512 |      1 | 2.828e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1416.9205902575336 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.2007779354054, dt = 0.011131123074244638 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.98 us    (1.6%)
   patch tree reduce : 1338.00 ns (0.4%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1276.00 ns (0.4%)
   LB compute        : 293.46 us  (93.1%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5842246947877363e-17,-7.345223062595052e-17,-1.1425430913869494e-17)
    sum a = (2.5950189263060364e-16,1.2740101942160242e-16,-1.1053657988924215e-16)
    sum e = 2.592001437344602
    sum de = 7.267542687441897e-19
Info: CFL hydro = 0.011130784649914679 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011130784649914679 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9544e+04 |  512 |      1 | 2.620e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.636895513823 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.211909058479645, dt = 0.011130784649914679 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.4%)
   patch tree reduce : 1279.00 ns (0.4%)
   gen split merge   : 761.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1210.00 ns (0.4%)
   LB compute        : 293.51 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.939183676916839e-17,-7.102326539387693e-17,-1.2924231997113455e-17)
    sum a = (-9.061891861894544e-17,1.979559094769656e-16,2.707209456609405e-17)
    sum e = 2.592001436961001
    sum de = -9.70276241079801e-19
Info: CFL hydro = 0.01113110526541163 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01113110526541163 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9510e+04 |  512 |      1 | 2.624e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1526.921128456954 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.22303984312956, dt = 0.01113110526541163 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1201.00 ns (0.4%)
   gen split merge   : 764.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1084.00 ns (0.4%)
   LB compute        : 275.96 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6338980949465177e-17,-6.854856038265161e-17,-1.185575075612899e-17)
    sum a = (-4.767036375016853e-17,1.184623688206543e-16,2.5936284370198237e-17)
    sum e = 2.592001436796209
    sum de = -1.3755815063409838e-18
Info: CFL hydro = 0.011132073013505044 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011132073013505044 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9146e+04 |  512 |      1 | 2.674e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1498.4984327116886 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.234170948394972, dt = 0.011132073013505044 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 2.20 us    (0.7%)
   gen split merge   : 771.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1004.00 ns (0.3%)
   LB compute        : 283.56 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.607369023038513e-17,-6.764949928364517e-17,-1.1659618583126363e-17)
    sum a = (-1.9376102285140195e-17,-2.2817197350283315e-17,1.1757391935041105e-16)
    sum e = 2.592001436882944
    sum de = -6.098637220230962e-20
Info: CFL hydro = 0.011132691542405182 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011132691542405182 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9679e+04 |  512 |      1 | 2.602e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1540.3232896043446 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.24530302140848, dt = 0.011132691542405182 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1329.00 ns (0.4%)
   gen split merge   : 644.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 958.00 ns  (0.3%)
   LB compute        : 304.32 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6168828971020732e-17,-6.86828523742411e-17,-9.903211063699845e-18)
    sum a = (4.6413068700845714e-17,5.1433466860539843e-17,1.6398991539712248e-16)
    sum e = 2.592001437231034
    sum de = -1.9481757786848908e-18
Info: CFL hydro = 0.011133776397914057 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011133776397914057 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9571e+04 |  512 |      1 | 2.616e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.968363819222 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.256435712950882, dt = 0.011133776397914057 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.6%)
   patch tree reduce : 1466.00 ns (0.5%)
   gen split merge   : 684.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1031.00 ns (0.4%)
   LB compute        : 267.63 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6896640336883095e-17,-6.792613346795485e-17,-7.792594694522314e-18)
    sum a = (-5.67451359338722e-17,-6.617265329439403e-18,8.414362956399301e-17)
    sum e = 2.5920014378536367
    sum de = -1.5280474368467578e-18
Info: CFL hydro = 0.011135483163279154 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011135483163279154 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9728e+04 |  512 |      1 | 2.595e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1544.4308100178944 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.267569489348798, dt = 0.011135483163279154 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.4%)
   patch tree reduce : 1197.00 ns (0.4%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1010.00 ns (0.3%)
   LB compute        : 293.53 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.44 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5693043788284414e-17,-6.832352066922508e-17,-7.286163859754336e-18)
    sum a = (-2.596409415592249e-17,-3.4970073711781954e-17,-7.259817746962938e-17)
    sum e = 2.592001438743286
    sum de = 1.7414997395548415e-18
Info: CFL hydro = 0.011137778098483044 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137778098483044 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9523e+04 |  512 |      1 | 2.623e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.5421056568873 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.278704972512077, dt = 0.011137778098483044 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.00 us    (1.7%)
   patch tree reduce : 1180.00 ns (0.4%)
   gen split merge   : 783.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1001.00 ns (0.3%)
   LB compute        : 276.62 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.572332352208286e-17,-6.84980636664681e-17,-9.048426070912274e-18)
    sum a = (7.501909250057226e-17,1.2170586803986193e-16,-9.95297594341693e-18)
    sum e = 2.5920014398755042
    sum de = 1.5958100726271018e-18
Info: CFL hydro = 0.011137492789040877 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137492789040877 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9218e+04 |  512 |      1 | 2.664e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1504.9722205294313 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.28984275061056, dt = 0.011137492789040877 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.5%)
   patch tree reduce : 1480.00 ns (0.5%)
   gen split merge   : 800.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1061.00 ns (0.4%)
   LB compute        : 280.40 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.59 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7004403256564577e-17,-6.636915138562988e-17,-8.682507837698416e-18)
    sum a = (9.341746126656503e-17,-1.790042723423535e-16,-1.1463486410123735e-17)
    sum e = 2.5920014411782866
    sum de = 1.0977546996415732e-18
Info: CFL hydro = 0.011139164835193989 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011139164835193989 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8699e+04 |  512 |      1 | 2.738e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1464.298628461205 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.3009802433996, dt = 0.011139164835193989 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.70 us    (1.6%)
   patch tree reduce : 1367.00 ns (0.5%)
   gen split merge   : 666.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 981.00 ns  (0.3%)
   LB compute        : 281.48 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.52 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1931.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8124444663597832e-17,-7.004443412002987e-17,-8.852293897909646e-18)
    sum a = (1.445581935405338e-16,2.4288188647803022e-17,8.085914750266543e-17)
    sum e = 2.5920014426460094
    sum de = -1.2807138162485021e-18
Info: CFL hydro = 0.011142911402560178 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011142911402560178 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9696e+04 |  512 |      1 | 2.600e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.633542081168 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.312119408234793, dt = 0.011142911402560178 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 2.27 us    (0.8%)
   gen split merge   : 794.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 981.00 ns  (0.3%)
   LB compute        : 283.67 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1965.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.004115867400638e-17,-6.918159892611159e-17,-7.517424183145493e-18)
    sum a = (2.7227243896976728e-17,-5.3719723981660025e-17,-1.6112697114045727e-16)
    sum e = 2.5920014442215136
    sum de = -1.0232158002831948e-18
Info: CFL hydro = 0.011148700393826066 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011148700393826066 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9185e+04 |  512 |      1 | 2.669e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1503.1155737609183 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.323262319637355, dt = 0.011148700393826066 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1367.00 ns (0.5%)
   gen split merge   : 782.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1070.00 ns (0.4%)
   LB compute        : 279.68 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.965246203077496e-17,-6.960642999487287e-17,-1.0558936537619079e-17)
    sum a = (-9.89062347647729e-17,3.002871389046202e-17,2.149257334604915e-17)
    sum e = 2.592001445836859
    sum de = 9.486769009248164e-19
Info: CFL hydro = 0.01115632172751768 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115632172751768 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9621e+04 |  512 |      1 | 2.609e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1538.0639288277716 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.33441102003118, dt = 0.01115632172751768 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1567.00 ns (0.5%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1060.00 ns (0.4%)
   LB compute        : 277.81 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1971.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7935207762302326e-17,-6.907731222964564e-17,-9.224066822854926e-18)
    sum a = (-5.356164730491164e-17,6.693083587361315e-17,-8.143290729234476e-17)
    sum e = 2.5920014474211794
    sum de = 1.8973538018496328e-19
Info: CFL hydro = 0.011161006708386668 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011161006708386668 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4449e+04 |  512 |      1 | 3.543e-02 | 0.0% |   1.3% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1133.4511584131815 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.3455673417587, dt = 0.011161006708386668 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.5%)
   patch tree reduce : 1800.00 ns (0.6%)
   gen split merge   : 847.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1033.00 ns (0.3%)
   LB compute        : 298.35 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.32 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7645309042038647e-17,-6.81259248232896e-17,-1.0737504635427442e-17)
    sum a = (4.1591730060019925e-17,8.08240193522769e-17,3.8359940224275134e-17)
    sum e = 2.5920014488538077
    sum de = 3.3881317890172014e-20
Info: CFL hydro = 0.011165848956596778 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011165848956596778 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9355e+04 |  512 |      1 | 2.645e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.866121063986 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.356728348467087, dt = 0.011165848956596778 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.5%)
   patch tree reduce : 1354.00 ns (0.5%)
   gen split merge   : 625.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 991.00 ns  (0.3%)
   LB compute        : 272.05 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8646278368995156e-17,-6.690009874202318e-17,-9.67780543204011e-18)
    sum a = (-4.846513815270903e-17,-8.943041619746683e-18,-4.5927129287137714e-17)
    sum e = 2.592001450103683
    sum de = -6.301925127571995e-19
Info: CFL hydro = 0.011170771815482254 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011170771815482254 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9179e+04 |  512 |      1 | 2.670e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1505.7188070877653 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.367894197423684, dt = 0.011170771815482254 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.4%)
   patch tree reduce : 1167.00 ns (0.4%)
   gen split merge   : 716.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 972.00 ns  (0.3%)
   LB compute        : 296.63 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7533338062675207e-17,-6.791296041155914e-17,-1.0737504635427442e-17)
    sum a = (7.212980213111565e-18,-1.1574432818434176e-16,3.762810375784742e-17)
    sum e = 2.5920014511179077
    sum de = 4.1335207826009857e-19
Info: CFL hydro = 0.011175698729314646 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011175698729314646 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9119e+04 |  512 |      1 | 2.678e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1501.6849298575448 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.379064969239167, dt = 0.011175698729314646 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.77 us    (1.5%)
   patch tree reduce : 1324.00 ns (0.4%)
   gen split merge   : 785.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1125.00 ns (0.4%)
   LB compute        : 298.46 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.56 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.79318230186451e-17,-6.972206015656845e-17,-9.865155567445604e-18)
    sum a = (8.69421722116126e-18,-6.430793397793621e-17,1.5760683773693996e-16)
    sum e = 2.5920014518562557
    sum de = -8.063753657860939e-19
Info: CFL hydro = 0.01118055404192564 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01118055404192564 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9262e+04 |  512 |      1 | 2.658e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1513.602266128091 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.39024066796848, dt = 0.01118055404192564 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.4%)
   patch tree reduce : 1585.00 ns (0.5%)
   gen split merge   : 767.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 2.17 us    (0.7%)
   LB compute        : 302.57 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7865225900200177e-17,-7.002138127133739e-17,-7.432531153039878e-18)
    sum a = (-2.483560232469095e-17,9.888574334371291e-17,1.1973137325343997e-16)
    sum e = 2.5920014522970964
    sum de = 8.944667923005412e-19
Info: CFL hydro = 0.011180366191615757 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011180366191615757 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9155e+04 |  512 |      1 | 2.673e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1505.8747474547554 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.401421222010406, dt = 0.011180366191615757 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.3%)
   patch tree reduce : 1217.00 ns (0.4%)
   gen split merge   : 665.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1048.00 ns (0.3%)
   LB compute        : 301.03 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.43 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.759042130705657e-17,-6.816690766540956e-17,-6.1649903931870755e-18)
    sum a = (-7.520936998184346e-17,-5.451303471126767e-17,-1.4070287903539257e-17)
    sum e = 2.5920014523795682
    sum de = -1.3552527156068805e-19
Info: CFL hydro = 0.011177641546571086 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011177641546571086 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9083e+04 |  512 |      1 | 2.683e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1500.1815824383393 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.412601588202023, dt = 0.011177641546571086 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 1465.00 ns (0.5%)
   gen split merge   : 764.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1068.00 ns (0.4%)
   LB compute        : 288.35 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6489007425082857e-17,-6.9498850034308e-17,-7.253963055231517e-18)
    sum a = (1.7227430419708423e-16,-1.5597484241680615e-16,-7.153408724744347e-17)
    sum e = 2.5920014521511563
    sum de = -7.860465750519907e-19
Info: CFL hydro = 0.011174815927289356 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011174815927289356 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9615e+04 |  512 |      1 | 2.610e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1541.6340933491472 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.423779229748593, dt = 0.011174815927289356 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.4%)
   patch tree reduce : 1594.00 ns (0.6%)
   gen split merge   : 799.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 941.00 ns  (0.3%)
   LB compute        : 271.15 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.990668372330029e-17,-7.15926341647577e-17,-8.316589604484558e-18)
    sum a = (-9.032618403237435e-17,-6.690156241495604e-17,1.1668986089896637e-16)
    sum e = 2.5920014516766203
    sum de = 1.1248597539537109e-18
Info: CFL hydro = 0.01117193150292233 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01117193150292233 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9429e+04 |  512 |      1 | 2.635e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1526.5892875245916 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.434954045675884, dt = 0.01117193150292233 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.75 us    (1.2%)
   patch tree reduce : 1575.00 ns (0.5%)
   gen split merge   : 636.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 913.00 ns  (0.3%)
   LB compute        : 294.23 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1996.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.707740394409074e-17,-7.188170956899665e-17,-5.91031130287023e-18)
    sum a = (-1.583108644176434e-17,1.7839831174815135e-16,-2.448432082080565e-17)
    sum e = 2.5920014510099953
    sum de = -1.9244588561617704e-18
Info: CFL hydro = 0.011169035714247658 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011169035714247658 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9893e+04 |  512 |      1 | 2.574e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1562.6737620527704 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.446125977178806, dt = 0.011169035714247658 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.90 us    (1.4%)
   patch tree reduce : 1108.00 ns (0.4%)
   gen split merge   : 626.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 855.00 ns  (0.3%)
   LB compute        : 270.56 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1822.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7534069899141636e-17,-6.892216289876296e-17,-6.96122846866043e-18)
    sum a = (5.854691731421724e-17,-6.645075115163656e-17,2.604752351309525e-17)
    sum e = 2.5920014502180613
    sum de = 1.0909784360635388e-18
Info: CFL hydro = 0.011166179551964474 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011166179551964474 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9997e+04 |  512 |      1 | 2.560e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1570.4163419923907 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.457295012893052, dt = 0.011166179551964474 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.91 us    (1.3%)
   patch tree reduce : 1220.00 ns (0.4%)
   gen split merge   : 665.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1801.00 ns (0.6%)
   LB compute        : 276.67 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1963.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.870134906309384e-17,-7.107156660066116e-17,-6.5221265888038e-18)
    sum a = (5.01278706044328e-17,3.9888014766176204e-17,-2.8032264010047217e-17)
    sum e = 2.5920014493748704
    sum de = -1.2197274440461925e-19
Info: CFL hydro = 0.011163417245499671 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011163417245499671 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9378e+04 |  512 |      1 | 2.642e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1521.4044215103916 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.468461192445016, dt = 0.011163417245499671 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.4%)
   patch tree reduce : 1895.00 ns (0.6%)
   gen split merge   : 699.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 992.00 ns  (0.3%)
   LB compute        : 283.73 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1879.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.923412601065322e-17,-7.003967718299808e-17,-6.96122846866043e-18)
    sum a = (1.135693102061186e-16,-2.0795865030009963e-17,-1.2341104700663853e-16)
    sum e = 2.59200144855871
    sum de = -3.9302328752599536e-19
Info: CFL hydro = 0.011160805326886191 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011160805326886191 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9424e+04 |  512 |      1 | 2.636e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1524.6090253535026 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.479624609690514, dt = 0.011160805326886191 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 983.00 ns  (0.3%)
   gen split merge   : 793.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 999.00 ns  (0.3%)
   LB compute        : 289.95 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.052801288329742e-17,-7.024312772066499e-17,-9.074772183703672e-18)
    sum a = (7.111108576984826e-17,-1.1763246626772529e-16,3.066687528918699e-17)
    sum e = 2.5920014478425184
    sum de = -4.743384504624082e-20
Info: CFL hydro = 0.01115840130668125 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115840130668125 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9512e+04 |  512 |      1 | 2.624e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.1955602492528 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.4907854150174, dt = 0.009214584982601082 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 2.08 us    (0.7%)
   gen split merge   : 732.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1020.00 ns (0.3%)
   LB compute        : 281.74 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1867.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.1013952297005423e-17,-7.210199234539139e-17,-7.84528692010511e-18)
    sum a = (6.766852703177228e-17,1.1399084801078095e-16,7.441313190637011e-18)
    sum e = 2.592001428707096
    sum de = 5.082197683525802e-19
Info: CFL hydro = 0.011156653836922364 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011156653836922364 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9496e+04 |  512 |      1 | 2.626e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1263.1586258635396 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 1841                                                    [SPH][rank=0]
Info: time since start : 1802.893638357 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14991788715734336 max=0.15009580584251683 delta=0.00017791868517347265
Number of particle pairs: 130816
Distance min=0.129609 max=1.973630 mean=0.800369
---------------- t = 16.5, dt = 0.011156653836922364 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.02 us    (1.9%)
   patch tree reduce : 1395.00 ns (0.3%)
   gen split merge   : 411.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 763.00 ns  (0.2%)
   LB compute        : 462.76 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 4.06 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.69 us    (79.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.186434627099443e-17,-6.988891887091397e-17,-7.827722844910844e-18)
    sum a = (1.5044215873061262e-16,5.5912306035077464e-18,1.5397839253639134e-18)
    sum e = 2.5920014468545585
    sum de = -2.501288293241949e-18
Info: CFL hydro = 0.011154735788309493 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011154735788309493 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4769e+04 |  512 |      1 | 3.467e-02 | 0.0% |   1.5% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1158.55632975834 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 16.511156653836924, dt = 0.011154735788309493 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.3%)
   patch tree reduce : 1157.00 ns (0.4%)
   gen split merge   : 720.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 762.00 ns  (0.2%)
   LB compute        : 294.94 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.58 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2000.00 ns (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3999845080030502e-17,-6.987428214158542e-17,-8.041419093107738e-18)
    sum a = (-2.8734827017817823e-16,2.959546670233681e-17,4.770988291935563e-17)
    sum e = 2.5920014468134736
    sum de = -1.5716696336303543e-18
Info: CFL hydro = 0.011153226322083258 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011153226322083258 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9198e+04 |  512 |      1 | 2.667e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1505.750407124844 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.522311389625234, dt = 0.011153226322083258 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.4%)
   patch tree reduce : 1419.00 ns (0.5%)
   gen split merge   : 758.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1070.00 ns (0.3%)
   LB compute        : 289.21 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1928.00 ns (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8235901070445813e-17,-6.965619487458996e-17,-6.96122846866043e-18)
    sum a = (-7.967064508118682e-17,-6.316041439857756e-17,1.6422410306637936e-17)
    sum e = 2.5920014470029034
    sum de = 6.2002811739014785e-19
Info: CFL hydro = 0.011152136018540091 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011152136018540091 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9065e+04 |  512 |      1 | 2.686e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1495.0763979193296 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.533464615947317, dt = 0.011152136018540091 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.81 us    (1.5%)
   patch tree reduce : 1246.00 ns (0.4%)
   gen split merge   : 882.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 906.00 ns  (0.3%)
   LB compute        : 301.54 us  (91.5%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8533026675815468e-17,-7.104814783373547e-17,-7.23347163417154e-18)
    sum a = (8.060739575821429e-17,4.2276728992596265e-17,-5.960076182587315e-18)
    sum e = 2.5920014474928275
    sum de = -6.488272375967941e-19
Info: CFL hydro = 0.011151512990926532 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011151512990926532 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8685e+04 |  512 |      1 | 2.740e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1465.143673787638 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.544616751965858, dt = 0.011151512990926532 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.99 us    (1.6%)
   patch tree reduce : 2.22 us    (0.7%)
   gen split merge   : 816.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1089.00 ns (0.3%)
   LB compute        : 298.67 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1965.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.047678433064748e-17,-6.971035077310562e-17,-7.239326325902962e-18)
    sum a = (-6.351755059419428e-17,-1.7069353742960037e-17,-7.400915817690202e-17)
    sum e = 2.5920014482678204
    sum de = 7.487771253728015e-19
Info: CFL hydro = 0.011151400637748336 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011151400637748336 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9254e+04 |  512 |      1 | 2.659e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.6530896546653 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.555768264956786, dt = 0.011151400637748336 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.5%)
   patch tree reduce : 1491.00 ns (0.5%)
   gen split merge   : 673.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 950.00 ns  (0.3%)
   LB compute        : 276.01 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1973.00 ns (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.87979514766623e-17,-7.033387544250203e-17,-8.571268694801404e-18)
    sum a = (1.7002024788048687e-16,4.27977965566928e-18,3.963626302172507e-17)
    sum e = 2.5920014492959194
    sum de = 8.131516293641283e-20
Info: CFL hydro = 0.011151836713292602 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011151836713292602 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9499e+04 |  512 |      1 | 2.626e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.866849258153 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.566919665594533, dt = 0.011151836713292602 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.87 us    (1.6%)
   patch tree reduce : 1307.00 ns (0.4%)
   gen split merge   : 1000.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 968.00 ns  (0.3%)
   LB compute        : 285.18 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1882.00 ns (63.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2028277639474238e-17,-7.079054139755292e-17,-7.400330348517059e-18)
    sum a = (1.2431852422500888e-16,-1.1993336011817401e-17,-6.740506590385831e-17)
    sum e = 2.5920014505281834
    sum de = -1.1316360175317453e-18
Info: CFL hydro = 0.011152852752109024 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011152852752109024 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9317e+04 |  512 |      1 | 2.651e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1514.6802509115776 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.578071502307825, dt = 0.011152852752109024 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.5%)
   patch tree reduce : 1216.00 ns (0.4%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 882.00 ns  (0.3%)
   LB compute        : 289.28 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1977.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3253371884274233e-17,-7.019775385974647e-17,-8.732272717415501e-18)
    sum a = (1.6761982427060396e-17,3.471832196733082e-17,7.13101452887166e-17)
    sum e = 2.5920014519019294
    sum de = -1.0028870095490916e-18
Info: CFL hydro = 0.011154473206569069 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011154473206569069 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8418e+04 |  512 |      1 | 2.780e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1444.3036169685247 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.589224355059933, dt = 0.011154473206569069 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.5%)
   patch tree reduce : 1616.00 ns (0.5%)
   gen split merge   : 724.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 285.00 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.273815901190912e-17,-6.973230586709845e-17,-7.034412115303201e-18)
    sum a = (-1.0789025922663953e-16,-6.346485836861149e-18,-4.112335472150619e-17)
    sum e = 2.5920014533452567
    sum de = -9.825582188149884e-19
Info: CFL hydro = 0.011156715111606088 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011156715111606088 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9311e+04 |  512 |      1 | 2.651e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1514.5931421140654 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.600378828266503, dt = 0.011156715111606088 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.5%)
   patch tree reduce : 1989.00 ns (0.7%)
   gen split merge   : 684.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1140.00 ns (0.4%)
   LB compute        : 278.81 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1891.00 ns (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0852948274391324e-17,-7.008066002511804e-17,-8.269752070633186e-18)
    sum a = (-1.5374420486713447e-16,1.1954695046390018e-16,7.005138656646093e-17)
    sum e = 2.592001454780302
    sum de = -6.166399856011306e-19
Info: CFL hydro = 0.011159247793567908 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011159247793567908 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9484e+04 |  512 |      1 | 2.628e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.4203127631947 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.61153554337811, dt = 0.011159247793567908 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.4%)
   patch tree reduce : 1481.00 ns (0.5%)
   gen split merge   : 643.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1279.00 ns (0.4%)
   LB compute        : 307.53 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.885210737517795e-17,-6.815885746427885e-17,-6.984647235586116e-18)
    sum a = (3.557896165184982e-17,-2.2277248405352943e-16,-6.748117689636679e-17)
    sum e = 2.5920014561263574
    sum de = -5.89534931288993e-19
Info: CFL hydro = 0.011162106961376619 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011162106961376619 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9606e+04 |  512 |      1 | 2.611e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1538.3815835180062 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.62269479117168, dt = 0.011162106961376619 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.6%)
   patch tree reduce : 1221.00 ns (0.4%)
   gen split merge   : 629.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 949.00 ns  (0.3%)
   LB compute        : 273.86 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1761.00 ns (62.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0403600684004708e-17,-7.238155387556677e-17,-8.299025529290294e-18)
    sum a = (5.112024085290878e-17,-1.0490290277068159e-16,7.40618504024848e-19)
    sum e = 2.592001457312342
    sum de = 8.402566836762659e-19
Info: CFL hydro = 0.011165569080307003 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011165569080307003 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9499e+04 |  512 |      1 | 2.626e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1530.349265951309 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.633856898133054, dt = 0.011165569080307003 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.3%)
   patch tree reduce : 1338.00 ns (0.4%)
   gen split merge   : 677.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 964.00 ns  (0.3%)
   LB compute        : 286.91 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0904176827041264e-17,-7.287042063514049e-17,-8.214132499184679e-18)
    sum a = (-5.592694276440602e-18,-3.752784216194682e-17,6.775159047071182e-17)
    sum e = 2.5920014582807287
    sum de = -1.2197274440461925e-19
Info: CFL hydro = 0.011169627835464224 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011169627835464224 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9572e+04 |  512 |      1 | 2.616e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.5906685107518 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.645022467213362, dt = 0.011169627835464224 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.4%)
   patch tree reduce : 1099.00 ns (0.4%)
   gen split merge   : 1105.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 1039.00 ns (0.4%)
   LB compute        : 277.52 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1938.00 ns (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0634861007395867e-17,-7.298605079683607e-17,-6.82657055883773e-18)
    sum a = (-8.66596833355715e-17,1.5487196486189958e-16,1.0366902648828447e-16)
    sum e = 2.592001458985349
    sum de = 5.89534931288993e-19
Info: CFL hydro = 0.011174268757897643 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011174268757897643 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9420e+04 |  512 |      1 | 2.636e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1525.204479971701 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.656192095048826, dt = 0.011174268757897643 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.81 us    (1.6%)
   patch tree reduce : 1466.00 ns (0.5%)
   gen split merge   : 883.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1013.00 ns (0.3%)
   LB compute        : 274.36 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1830.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.918289745800328e-17,-7.043194152900334e-17,-5.500482881670709e-18)
    sum a = (-3.0032007154560947e-17,-4.743343169416256e-17,7.981408502860665e-17)
    sum e = 2.592001459397831
    sum de = 1.1722935989999517e-18
Info: CFL hydro = 0.011175750595459999 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011175750595459999 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9097e+04 |  512 |      1 | 2.681e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1500.4220713375423 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.667366363806725, dt = 0.011175750595459999 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.07 us    (1.7%)
   patch tree reduce : 1268.00 ns (0.4%)
   gen split merge   : 759.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 968.00 ns  (0.3%)
   LB compute        : 283.56 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1961.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9343901480617376e-17,-7.182828550694742e-17,-4.803774565631525e-18)
    sum a = (2.5945066407795368e-17,9.099435072622287e-17,-1.3471645674001387e-17)
    sum e = 2.5920014594651204
    sum de = -8.673617379884035e-19
Info: CFL hydro = 0.011175818161283883 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011175818161283883 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8978e+04 |  512 |      1 | 2.698e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1491.280400215133 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.678542114402184, dt = 0.011175818161283883 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 1571.00 ns (0.5%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1039.00 ns (0.3%)
   LB compute        : 280.23 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.970396502209981e-17,-7.012017919430513e-17,-5.441935964356492e-18)
    sum a = (-9.223042251801927e-17,2.1614790035942575e-17,-2.7177479017259643e-17)
    sum e = 2.5920014592217777
    sum de = 1.3349239248727773e-18
Info: CFL hydro = 0.011176638571161707 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011176638571161707 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9393e+04 |  512 |      1 | 2.640e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.8634538248248 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.689717932563468, dt = 0.011176638571161707 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1559.00 ns (0.5%)
   gen split merge   : 608.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1345.00 ns (0.4%)
   LB compute        : 284.12 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1802.00 ns (63.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7912429352284764e-17,-7.063246472080454e-17,-5.708324438136181e-18)
    sum a = (1.3233359720532522e-16,8.967045855845512e-17,1.8723304157086674e-17)
    sum e = 2.5920014587273097
    sum de = 1.0638733817514012e-18
Info: CFL hydro = 0.01117242632456061 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01117242632456061 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9455e+04 |  512 |      1 | 2.632e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.8667554916624 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.70089457113463, dt = 0.01117242632456061 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.56 us    (1.5%)
   patch tree reduce : 1786.00 ns (0.6%)
   gen split merge   : 684.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 995.00 ns  (0.3%)
   LB compute        : 286.87 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.68 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1987.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0775373608949987e-17,-6.913073629169487e-17,-5.359970280116588e-18)
    sum a = (2.0630762723183872e-16,-7.081981485621003e-17,5.372265132752574e-17)
    sum e = 2.5920014579687654
    sum de = 1.4230153513872246e-19
Info: CFL hydro = 0.011165731796210138 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011165731796210138 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9432e+04 |  512 |      1 | 2.635e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1526.534525102274 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.71206699745919, dt = 0.011165731796210138 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.66 us    (1.5%)
   patch tree reduce : 1343.00 ns (0.4%)
   gen split merge   : 686.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1262.00 ns (0.4%)
   LB compute        : 292.12 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.33 us    (70.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3445113038478293e-17,-7.070711204038016e-17,-4.393946144432004e-18)
    sum a = (-5.65153392834139e-17,-2.4472611437342806e-17,-3.2072001304728205e-17)
    sum e = 2.592001457041597
    sum de = 6.776263578034403e-20
Info: CFL hydro = 0.011159786044039699 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011159786044039699 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9493e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1530.3896476065229 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.7232327292554, dt = 0.011159786044039699 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.4%)
   patch tree reduce : 1248.00 ns (0.4%)
   gen split merge   : 642.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1615.00 ns (0.6%)
   LB compute        : 274.20 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1894.00 ns (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.125253098506086e-17,-7.063831941253596e-17,-5.248731137219576e-18)
    sum a = (-1.0805419059511934e-16,-1.1069612023892339e-16,-1.0571231390255065e-16)
    sum e = 2.592001456056407
    sum de = -1.1350241493207625e-18
Info: CFL hydro = 0.011154673139855594 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011154673139855594 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9442e+04 |  512 |      1 | 2.634e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1525.5376681116913 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.73439251529944, dt = 0.011154673139855594 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.6%)
   patch tree reduce : 2.08 us    (0.7%)
   gen split merge   : 627.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 272.03 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1923.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.006695590944796e-17,-7.251913913125518e-17,-7.040266807034623e-18)
    sum a = (1.519995067311708e-16,1.3675096211668292e-16,-2.37700484295722e-17)
    sum e = 2.5920014550928103
    sum de = 1.2163393122571753e-18
Info: CFL hydro = 0.01115046539180776 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115046539180776 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7888e+04 |  512 |      1 | 2.862e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1403.0027998856176 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.745547188439296, dt = 0.01115046539180776 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.5%)
   patch tree reduce : 1527.00 ns (0.5%)
   gen split merge   : 635.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1049.00 ns (0.3%)
   LB compute        : 286.06 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3219707406818556e-17,-6.952592798356583e-17,-6.770950987389224e-18)
    sum a = (-1.3544243851471015e-16,-1.1392351905586962e-16,5.517461487691833e-17)
    sum e = 2.592001454228172
    sum de = 1.9193766584782446e-18
Info: CFL hydro = 0.011147221620271059 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011147221620271059 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8780e+04 |  512 |      1 | 2.726e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1472.352343436973 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.756697653831104, dt = 0.011147221620271059 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.3%)
   patch tree reduce : 1821.00 ns (0.6%)
   gen split merge   : 658.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1426.00 ns (0.5%)
   LB compute        : 294.87 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.42 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.993815269135668e-17,-7.205076379274145e-17,-5.7200338215990246e-18)
    sum a = (-1.765248103940964e-16,-4.777428452840127e-18,8.956507410728953e-17)
    sum e = 2.5920014535345253
    sum de = 1.5195771073742148e-18
Info: CFL hydro = 0.011144986632433823 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011144986632433823 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9519e+04 |  512 |      1 | 2.623e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.8947019501836 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.767844875451374, dt = 0.011144986632433823 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.6%)
   patch tree reduce : 1120.00 ns (0.4%)
   gen split merge   : 644.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1621.00 ns (0.6%)
   LB compute        : 273.13 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.41 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7874373856030523e-17,-7.137308322482937e-17,-4.472984482806197e-18)
    sum a = (9.294323123631987e-17,5.760138459959263e-17,-1.2751518591036514e-17)
    sum e = 2.592001453071552
    sum de = 5.768294370801785e-19
Info: CFL hydro = 0.011142506159318066 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011142506159318066 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0045e+04 |  512 |      1 | 2.554e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1570.7703058191023 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.778989862083808, dt = 0.011142506159318066 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1560.00 ns (0.5%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 933.00 ns  (0.3%)
   LB compute        : 276.96 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.74 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0225032586196346e-17,-7.055928107416176e-17,-5.178474836442515e-18)
    sum a = (4.0204168119672977e-17,1.4322186015283677e-16,6.920245626540477e-17)
    sum e = 2.5920014528705644
    sum de = -8.472976450503173e-20
Info: CFL hydro = 0.011133450110390086 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011133450110390086 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0272e+04 |  512 |      1 | 2.526e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1588.2490844813992 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.790132368243125, dt = 0.011133450110390086 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1166.00 ns (0.4%)
   gen split merge   : 641.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 908.00 ns  (0.3%)
   LB compute        : 288.56 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.65 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0548504304357395e-17,-6.837548105834146e-17,-3.981190377366772e-18)
    sum a = (-7.371056889859951e-18,7.525328016982912e-17,6.415571199291925e-17)
    sum e = 2.5920014528957873
    sum de = -8.682087709356578e-19
Info: CFL hydro = 0.011126523580853948 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011126523580853948 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0005e+04 |  512 |      1 | 2.559e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1566.0441887634033 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.801265818353514, dt = 0.011126523580853948 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.3%)
   patch tree reduce : 1282.00 ns (0.4%)
   gen split merge   : 980.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 973.00 ns  (0.3%)
   LB compute        : 288.92 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1975.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.01050114057022e-17,-6.817495786654026e-17,-3.1059139635192244e-18)
    sum a = (7.283236513888625e-18,-2.011086609743362e-18,1.4299499084824418e-16)
    sum e = 2.5920014532381597
    sum de = -1.2095630486791409e-18
Info: CFL hydro = 0.011121827567675395 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011121827567675395 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9412e+04 |  512 |      1 | 2.638e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.6693171839138 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.812392341934366, dt = 0.011121827567675395 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.5%)
   patch tree reduce : 1481.00 ns (0.5%)
   gen split merge   : 715.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1017.00 ns (0.3%)
   LB compute        : 274.82 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.72 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.028797052230913e-17,-6.854965813735126e-17,-1.1738656921500556e-18)
    sum a = (-2.2681075767527758e-17,1.8222728014050117e-18,5.817221704340625e-17)
    sum e = 2.5920014538848806
    sum de = 8.978549240895584e-20
Info: CFL hydro = 0.011119430955820292 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011119430955820292 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9651e+04 |  512 |      1 | 2.605e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.71635982544 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 16.82351416950204, dt = 0.011119430955820292 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1358.00 ns (0.5%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1312.00 ns (0.4%)
   LB compute        : 281.18 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1947.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9769830304078307e-17,-6.872822623515961e-17,-1.103609391372995e-18)
    sum a = (1.7883155893627656e-16,-2.238541383509096e-17,8.723490679818368e-18)
    sum e = 2.5920014548062347
    sum de = 2.473336205982557e-19
Info: CFL hydro = 0.011119369210264492 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011119369210264492 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9284e+04 |  512 |      1 | 2.655e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1507.721666369041 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.83463360045786, dt = 0.011119369210264492 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.4%)
   patch tree reduce : 14.28 us   (4.7%)
   gen split merge   : 659.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 935.00 ns  (0.3%)
   LB compute        : 274.15 us  (90.3%)
   LB move op cnt    : 0
   LB apply          : 2.78 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.300747483155452e-17,-6.869017073890537e-17,-1.2031391508071642e-18)
    sum a = (-4.563732204643234e-17,-1.952173774195931e-18,5.03152207398383e-17)
    sum e = 2.5920014559569333
    sum de = 2.574980159653073e-19
Info: CFL hydro = 0.011121644282479994 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011121644282479994 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9670e+04 |  512 |      1 | 2.603e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.8290707347446 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.845752969668123, dt = 0.011121644282479994 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.6%)
   patch tree reduce : 1327.00 ns (0.5%)
   gen split merge   : 683.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1275.00 ns (0.4%)
   LB compute        : 273.83 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1978.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.1300832191845086e-17,-6.875457234795102e-17,-5.0643083476797915e-19)
    sum a = (-4.4882066813078936e-17,-7.504365476197674e-17,-6.334776453398305e-18)
    sum e = 2.5920014572783034
    sum de = 8.334804200982315e-19
Info: CFL hydro = 0.011126224292950187 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011126224292950187 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9589e+04 |  512 |      1 | 2.614e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.86449139257 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 16.856874613950602, dt = 0.011126224292950187 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.5%)
   patch tree reduce : 1326.00 ns (0.4%)
   gen split merge   : 661.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1076.00 ns (0.4%)
   LB compute        : 288.38 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (68.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0731463420964324e-17,-6.987574581451828e-17,-7.698919626819567e-19)
    sum a = (-1.5029579143732707e-16,1.3179862474836655e-16,3.1252344462329163e-17)
    sum e = 2.5920014587055373
    sum de = -2.405573570202213e-19
Info: CFL hydro = 0.01113284130092273 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01113284130092273 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9531e+04 |  512 |      1 | 2.621e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.951296737745 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.868000838243553, dt = 0.01113284130092273 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1406.00 ns (0.5%)
   gen split merge   : 645.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 909.00 ns  (0.3%)
   LB compute        : 272.92 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1995.00 ns (63.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8584255228465408e-17,-6.72543075917742e-17,-3.688455790795686e-19)
    sum a = (-1.0832350641476473e-16,-4.341985755315636e-17,5.750478218602418e-17)
    sum e = 2.5920014601669514
    sum de = 6.606856988583543e-19
Info: CFL hydro = 0.011140190824983933 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011140190824983933 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9011e+04 |  512 |      1 | 2.693e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1488.144507123612 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.879133679544477, dt = 0.011140190824983933 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.3%)
   patch tree reduce : 2.17 us    (0.7%)
   gen split merge   : 1034.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1044.00 ns (0.3%)
   LB compute        : 298.85 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (70.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7610912728116544e-17,-6.892289473522939e-17,4.391018798566293e-19)
    sum a = (9.660241356845845e-19,-1.254645801314347e-16,3.2669179861333217e-18)
    sum e = 2.592001461580837
    sum de = -5.692061405548898e-19
Info: CFL hydro = 0.011138959619502838 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011138959619502838 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9649e+04 |  512 |      1 | 2.606e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1539.1197743469754 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.890273870369462, dt = 0.011138959619502838 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.81 us    (1.6%)
   patch tree reduce : 1415.00 ns (0.5%)
   gen split merge   : 789.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1056.00 ns (0.4%)
   LB compute        : 273.62 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1796.00 ns (64.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8087338267760987e-17,-7.07876140516872e-17,2.5175174445113414e-19)
    sum a = (-5.2750772500109735e-17,-4.3699419083331746e-17,-1.3064744598667577e-17)
    sum e = 2.59200146278269
    sum de = 1.3891340334970526e-18
Info: CFL hydro = 0.011138060933188237 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011138060933188237 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9473e+04 |  512 |      1 | 2.629e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1525.1109494135783 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.901412829988963, dt = 0.011138060933188237 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.4%)
   patch tree reduce : 1204.00 ns (0.4%)
   gen split merge   : 743.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1366.00 ns (0.4%)
   LB compute        : 316.79 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.735989282013184e-17,-7.071296673211158e-17,1.1709383462843448e-20)
    sum a = (-1.4913070778277416e-16,-5.551711434320649e-17,5.710080845655608e-17)
    sum e = 2.59200146381058
    sum de = -3.083199928005653e-19
Info: CFL hydro = 0.011137471250215816 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137471250215816 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9504e+04 |  512 |      1 | 2.625e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.4784994077686 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.91255089092215, dt = 0.011137471250215816 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.02 us    (1.4%)
   patch tree reduce : 1271.00 ns (0.4%)
   gen split merge   : 782.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 269.37 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1902.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5137305471590866e-17,-7.139357464588936e-17,9.074772183703671e-19)
    sum a = (1.379892294178786e-16,-9.261536849936025e-17,-3.094703143649135e-17)
    sum e = 2.5920014646263363
    sum de = 1.0503208545953324e-19
Info: CFL hydro = 0.011137163702668937 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137163702668937 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9835e+04 |  512 |      1 | 2.581e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1553.262935640704 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.923688362172367, dt = 0.011137163702668937 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.6%)
   patch tree reduce : 1431.00 ns (0.5%)
   gen split merge   : 716.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1324.00 ns (0.5%)
   LB compute        : 274.60 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.822199617758369e-17,-7.25776860485694e-17,-4.098284211995207e-20)
    sum a = (4.913257301009111e-17,8.720270599366087e-17,5.902553836326096e-17)
    sum e = 2.592001465207284
    sum de = -1.5924219408380846e-19
Info: CFL hydro = 0.011137108178062826 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137108178062826 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9547e+04 |  512 |      1 | 2.619e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1530.7011857597456 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.934825525875038, dt = 0.011137108178062826 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.5%)
   patch tree reduce : 2.14 us    (0.7%)
   gen split merge   : 784.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 929.00 ns  (0.3%)
   LB compute        : 272.40 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1975.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8394709583660628e-17,-7.094276338256989e-17,1.3407244064955747e-18)
    sum a = (-3.952795122469377e-17,2.2540563165973638e-17,-3.881075148759461e-17)
    sum e = 2.5920014655462036
    sum de = -4.2351647362715017e-19
Info: CFL hydro = 0.0111372715838069 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0111372715838069 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9124e+04 |  512 |      1 | 2.677e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1497.5796752379338 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.9459626340531, dt = 0.0111372715838069 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.6%)
   patch tree reduce : 1249.00 ns (0.4%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 962.00 ns  (0.3%)
   LB compute        : 270.94 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1979.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.726329040656338e-17,-7.076273161182867e-17,2.927345865710862e-19)
    sum a = (8.873956257315906e-17,2.8143503152944224e-17,1.7973903615464693e-17)
    sum e = 2.5920014656527774
    sum de = 1.7279472123987727e-19
Info: CFL hydro = 0.011137618293221905 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137618293221905 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9533e+04 |  512 |      1 | 2.621e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.6169092957612 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.957099905636905, dt = 0.011137618293221905 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 1195.00 ns (0.4%)
   gen split merge   : 790.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 878.00 ns  (0.3%)
   LB compute        : 290.05 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.924656723058249e-17,-7.061343697267741e-17,7.728193085476676e-19)
    sum a = (2.0962723744355483e-17,-5.629286099761988e-17,1.3817072486155268e-18)
    sum e = 2.592001465555392
    sum de = -7.724940478959219e-19
Info: CFL hydro = 0.01113811055196645 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01113811055196645 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9143e+04 |  512 |      1 | 2.675e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1499.149251859703 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 16.968237523930128, dt = 0.01113811055196645 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1339.00 ns (0.5%)
   gen split merge   : 752.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 941.00 ns  (0.3%)
   LB compute        : 279.92 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.44 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.33 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9019697925989897e-17,-7.188097773253022e-17,6.323067069935462e-19)
    sum a = (1.607025059899292e-16,2.551416109636273e-16,-5.564299021543207e-17)
    sum e = 2.5920014652938925
    sum de = 1.5246593050577406e-18
Info: CFL hydro = 0.011138708865775188 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011138708865775188 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9779e+04 |  512 |      1 | 2.589e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1548.9647879892375 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.979375634482093, dt = 0.011138708865775188 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 1108.00 ns (0.4%)
   gen split merge   : 715.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 991.00 ns  (0.3%)
   LB compute        : 282.82 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1933.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.1640404312267547e-17,-6.710794029848866e-17,-1.5807667674838654e-19)
    sum a = (2.3073340113533013e-17,1.3032543794144757e-17,-9.502164680097458e-17)
    sum e = 2.592001464918118
    sum de = -1.0164395367051604e-19
Info: CFL hydro = 0.011139372774094181 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011139372774094181 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9188e+04 |  512 |      1 | 2.668e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1502.7741966123876 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 16.99051434334787, dt = 0.009485656652131524 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.6%)
   patch tree reduce : 1237.00 ns (0.4%)
   gen split merge   : 630.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1005.00 ns (0.3%)
   LB compute        : 279.69 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.55 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.115300122562669e-17,-6.817642153947312e-17,-1.375852556884105e-18)
    sum a = (-3.143625496634245e-16,-4.947214513051357e-18,1.8443449892324714e-16)
    sum e = 2.592001448330273
    sum de = 5.251604272976662e-19
Info: CFL hydro = 0.011139893049327455 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011139893049327455 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8614e+04 |  512 |      1 | 2.751e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1241.4503578810602 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 1886                                                    [SPH][rank=0]
Info: time since start : 1804.7227859240002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14991661511751617 max=0.1500934193675788 delta=0.0001768042500626399
Number of particle pairs: 130816
Distance min=0.128141 max=1.974197 mean=0.800456
---------------- t = 17, dt = 0.011139893049327455 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.92 us    (1.5%)
   patch tree reduce : 1222.00 ns (0.2%)
   gen split merge   : 416.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 855.00 ns  (0.1%)
   LB compute        : 657.53 us  (96.2%)
   LB move op cnt    : 0
   LB apply          : 5.74 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.51 us    (78.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5960621496322046e-17,-6.816763950187599e-17,2.034505376669049e-18)
    sum a = (-1.9970367789560484e-16,-1.9987917571073765e-17,8.522089284257461e-17)
    sum e = 2.5920014639811795
    sum de = 9.317362419797304e-20
Info: CFL hydro = 0.011139419920691037 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011139419920691037 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7442e+04 |  512 |      1 | 2.935e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1366.1859389821257 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.01113989304933, dt = 0.011139419920691037 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.3%)
   patch tree reduce : 1076.00 ns (0.4%)
   gen split merge   : 714.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 859.00 ns  (0.3%)
   LB compute        : 291.40 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.434545841491608e-17,-6.855844017494839e-17,2.3682228053600873e-18)
    sum a = (-9.350308613313706e-17,3.766323190823595e-17,6.172016023264782e-17)
    sum e = 2.592001463611867
    sum de = -6.403569081242511e-19
Info: CFL hydro = 0.011138951923245623 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011138951923245623 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9858e+04 |  512 |      1 | 2.578e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1555.3867656970694 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.02227931297002, dt = 0.011138951923245623 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.4%)
   patch tree reduce : 1107.00 ns (0.4%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 871.00 ns  (0.3%)
   LB compute        : 287.79 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3952462232444396e-17,-6.768609110696655e-17,2.8248887604109818e-18)
    sum a = (-8.329616293586972e-17,-1.4099268627609794e-16,-3.892199063049162e-17)
    sum e = 2.5920014632885797
    sum de = 4.1335207826009857e-19
Info: CFL hydro = 0.011138462436560982 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011138462436560982 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9307e+04 |  512 |      1 | 2.652e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1512.1664385678034 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.033418264893267, dt = 0.011138462436560982 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.4%)
   patch tree reduce : 2.08 us    (0.7%)
   gen split merge   : 756.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 993.00 ns  (0.3%)
   LB compute        : 301.85 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.315695599343747e-17,-7.061636431854313e-17,1.9027748127120604e-18)
    sum a = (3.529208175701015e-17,3.429092947093704e-17,-5.4460342485684875e-17)
    sum e = 2.592001463097054
    sum de = 5.277015261394291e-19
Info: CFL hydro = 0.011137931255660209 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137931255660209 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8732e+04 |  512 |      1 | 2.733e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1467.0129963896024 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.04455672732983, dt = 0.011137931255660209 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.74 us    (1.6%)
   patch tree reduce : 1836.00 ns (0.6%)
   gen split merge   : 861.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 284.55 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3956853251242963e-17,-6.883653803219092e-17,1.1972844590757425e-18)
    sum a = (-2.0374327225347597e-18,6.48172921585699e-17,3.805549625424121e-18)
    sum e = 2.592001463059751
    sum de = -8.934080011164733e-19
Info: CFL hydro = 0.011135028807285804 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011135028807285804 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9082e+04 |  512 |      1 | 2.683e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1494.4107408388752 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.05569465858549, dt = 0.011135028807285804 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 2.28 us    (0.7%)
   gen split merge   : 929.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1072.00 ns (0.3%)
   LB compute        : 298.74 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.40 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4013936495624325e-17,-6.814861175374886e-17,1.6978606021123e-18)
    sum a = (-1.0023817713367133e-16,-5.396854838024545e-17,-4.683753385137379e-17)
    sum e = 2.5920014631645927
    sum de = 8.851494298807439e-19
Info: CFL hydro = 0.01113139269105389 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01113139269105389 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9295e+04 |  512 |      1 | 2.654e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.6798831869364 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.066829687392776, dt = 0.01113139269105389 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 2.25 us    (0.7%)
   gen split merge   : 795.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1020.00 ns (0.3%)
   LB compute        : 291.68 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2384136684889802e-17,-6.936931497975029e-17,7.230544288305829e-19)
    sum a = (-3.3477127320269417e-17,-4.502257941463305e-18,-8.77501196705488e-17)
    sum e = 2.5920014634252135
    sum de = -2.244637310223896e-19
Info: CFL hydro = 0.011128192593725435 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011128192593725435 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9513e+04 |  512 |      1 | 2.624e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.2363349798704 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.07796108008383, dt = 0.011128192593725435 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.5%)
   patch tree reduce : 1637.00 ns (0.5%)
   gen split merge   : 672.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 286.45 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1836.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2040905382135203e-17,-6.929613133310753e-17,-4.24465150528075e-19)
    sum a = (-1.4769923565444155e-16,6.82657055883773e-18,7.37105688985995e-17)
    sum e = 2.592001463836515
    sum de = 4.912791094074942e-19
Info: CFL hydro = 0.011125484619821878 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011125484619821878 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8979e+04 |  512 |      1 | 2.698e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1484.9897389926296 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.08908927267756, dt = 0.011125484619821878 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.4%)
   patch tree reduce : 1218.00 ns (0.4%)
   gen split merge   : 788.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 898.00 ns  (0.3%)
   LB compute        : 275.46 us  (90.7%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.95004859755122e-18,-6.897119594201362e-17,1.2529040305242488e-18)
    sum a = (-5.725888513330446e-17,-1.3706418812431397e-16,5.449547063607341e-17)
    sum e = 2.592001464370757
    sum de = -6.2849844686269085e-19
Info: CFL hydro = 0.011123320127007395 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011123320127007395 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9729e+04 |  512 |      1 | 2.595e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1543.3177169494704 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.10021475729738, dt = 0.011123320127007395 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.4%)
   patch tree reduce : 1421.00 ns (0.5%)
   gen split merge   : 641.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 834.00 ns  (0.3%)
   LB compute        : 294.73 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.774407845608569e-18,-7.139503831882222e-17,1.8617919705921083e-18)
    sum a = (-6.1474263179928104e-18,-1.3705833343258256e-17,2.846551119817242e-17)
    sum e = 2.5920014649911574
    sum de = -1.7110065534536867e-19
Info: CFL hydro = 0.011121744947320428 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011121744947320428 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9350e+04 |  512 |      1 | 2.646e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1513.3943898680998 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.11133807742439, dt = 0.011121744947320428 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.92 us    (1.2%)
   patch tree reduce : 1330.00 ns (0.4%)
   gen split merge   : 668.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 938.00 ns  (0.3%)
   LB compute        : 304.43 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (70.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.791240084336406e-18,-7.089738952165137e-17,1.6363863389323718e-18)
    sum a = (1.1771443195196517e-16,1.626491909906269e-16,-7.561919840304298e-17)
    sum e = 2.5920014656555823
    sum de = -9.215718466126788e-19
Info: CFL hydro = 0.011120008103118667 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011120008103118667 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9451e+04 |  512 |      1 | 2.632e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1521.0900669982134 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.12245982237171, dt = 0.011120008103118667 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.3%)
   patch tree reduce : 1357.00 ns (0.5%)
   gen split merge   : 841.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 895.00 ns  (0.3%)
   LB compute        : 282.40 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.180159485761334e-17,-6.800809915219475e-17,4.112920941323761e-19)
    sum a = (-5.0444023957929575e-17,-1.5198779734770795e-17,-8.664943762504152e-18)
    sum e = 2.592001466311655
    sum de = 4.404571325722362e-20
Info: CFL hydro = 0.011118863269676076 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011118863269676076 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8970e+04 |  512 |      1 | 2.699e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1483.1962043967962 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.13357983047483, dt = 0.011118863269676076 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.76 us    (1.5%)
   patch tree reduce : 1216.00 ns (0.4%)
   gen split merge   : 660.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 972.00 ns  (0.3%)
   LB compute        : 295.19 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0512099003767705e-17,-6.903267020519354e-17,7.698919626819567e-19)
    sum a = (8.985780869386062e-17,-9.201233525102381e-17,3.357080238797217e-17)
    sum e = 2.5920014669223974
    sum de = 8.74138001566438e-19
Info: CFL hydro = 0.011118418465349713 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011118418465349713 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9147e+04 |  512 |      1 | 2.674e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1496.8977956096257 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.144698693744505, dt = 0.011118418465349713 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.4%)
   patch tree reduce : 1210.00 ns (0.4%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 920.00 ns  (0.3%)
   LB compute        : 295.58 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1954.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2123602902841534e-17,-7.076858630356009e-17,1.3012052373084782e-18)
    sum a = (1.6413628269040802e-16,3.563165387743261e-17,3.348883670373226e-17)
    sum e = 2.59200146745093
    sum de = 8.538092108323347e-19
Info: CFL hydro = 0.011118702135355634 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011118702135355634 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9463e+04 |  512 |      1 | 2.631e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1521.5654371245046 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.155817112209856, dt = 0.011118702135355634 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1325.00 ns (0.4%)
   gen split merge   : 779.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 954.00 ns  (0.3%)
   LB compute        : 299.99 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (70.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4324966993856104e-17,-6.95566651151558e-17,1.762262211157939e-18)
    sum a = (-7.274454476291492e-17,-4.508112633194727e-18,-1.8828688608252263e-17)
    sum e = 2.592001467865818
    sum de = 3.2864878353466853e-19
Info: CFL hydro = 0.01111973392616992 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01111973392616992 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9031e+04 |  512 |      1 | 2.690e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1487.8308530512375 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.166935814345212, dt = 0.01111973392616992 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.6%)
   patch tree reduce : 1338.00 ns (0.5%)
   gen split merge   : 771.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 975.00 ns  (0.3%)
   LB compute        : 280.25 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1793.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2148485342700077e-17,-6.962106672420143e-17,1.3158419666370324e-18)
    sum a = (2.1143048249683273e-16,-9.572420980874518e-18,-2.5426926189564546e-17)
    sum e = 2.592001468148047
    sum de = 9.0801931945661e-19
Info: CFL hydro = 0.011121523831074337 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011121523831074337 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8798e+04 |  512 |      1 | 2.724e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1469.753320432972 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.17805554827138, dt = 0.011121523831074337 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.0%)
   patch tree reduce : 1408.00 ns (0.3%)
   gen split merge   : 746.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1597.00 ns (0.4%)
   LB compute        : 412.10 us  (95.9%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.66 us    (71.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6079910840349766e-17,-6.986110908518972e-17,9.87979229677416e-19)
    sum a = (1.7312323449814037e-16,-1.7101554547482857e-17,-1.2517330921779646e-17)
    sum e = 2.592001468287714
    sum de = 3.4897757426877174e-19
Info: CFL hydro = 0.011120085431111327 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011120085431111327 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9014e+04 |  512 |      1 | 2.693e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1486.8817263895119 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.189177072102456, dt = 0.011120085431111327 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.75 us    (1.5%)
   patch tree reduce : 1109.00 ns (0.3%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1160.00 ns (0.4%)
   LB compute        : 300.29 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7764598386066367e-17,-7.019189916801504e-17,9.528510792888855e-19)
    sum a = (-8.051957538224297e-17,-1.0803369917405936e-17,-1.0611043294028733e-16)
    sum e = 2.592001468249525
    sum de = -2.202285662861181e-19
Info: CFL hydro = 0.01111760360578536 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01111760360578536 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9229e+04 |  512 |      1 | 2.663e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1503.459035318689 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.20029715753357, dt = 0.01111760360578536 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.75 us    (1.5%)
   patch tree reduce : 1218.00 ns (0.4%)
   gen split merge   : 1045.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 956.00 ns  (0.3%)
   LB compute        : 301.07 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.32 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5547133892790387e-17,-7.002211310780382e-17,-9.235776206317769e-19)
    sum a = (3.6427891952905966e-17,4.363263900577022e-17,3.276578227490168e-17)
    sum e = 2.5920014680712113
    sum de = -1.3992984288641042e-18
Info: CFL hydro = 0.011114974586323286 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011114974586323286 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9490e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.5667376701342 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.211414761139356, dt = 0.011114974586323286 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.5%)
   patch tree reduce : 1119.00 ns (0.4%)
   gen split merge   : 690.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1586.00 ns (0.5%)
   LB compute        : 277.41 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1946.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6592196366849166e-17,-6.957130184448435e-17,3.5713619561672516e-19)
    sum a = (1.88222484473477e-16,8.605079539550364e-17,-1.9898633522169584e-17)
    sum e = 2.5920014677884424
    sum de = -2.0328790734103208e-19
Info: CFL hydro = 0.011112211167309198 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011112211167309198 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9672e+04 |  512 |      1 | 2.603e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.4154858814543 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.22252973572568, dt = 0.011112211167309198 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1416.00 ns (0.5%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 893.00 ns  (0.3%)
   LB compute        : 293.98 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.58 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.501953125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9351219845281652e-17,-6.833010719742294e-17,-1.507583120841094e-19)
    sum a = (3.0011149815267754e-17,-7.856996303567954e-18,-5.876573641767912e-17)
    sum e = 2.5920014674368717
    sum de = 3.3881317890172014e-21
Info: CFL hydro = 0.011109328592143357 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011109328592143357 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8627e+04 |  512 |      1 | 2.749e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1455.4033504766433 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.233641946892988, dt = 0.011109328592143357 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.3%)
   patch tree reduce : 1417.00 ns (0.4%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1002.00 ns (0.3%)
   LB compute        : 308.14 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.884332533758082e-17,-6.884239272392234e-17,-1.0670175680516092e-18)
    sum a = (-1.4010277313292186e-17,-2.5825045227301223e-17,-1.9039457510583447e-17)
    sum e = 2.5920014670590974
    sum de = -1.0164395367051604e-20
Info: CFL hydro = 0.01110634453604931 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01110634453604931 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8640e+04 |  512 |      1 | 2.747e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1456.0335088420202 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.244751275485132, dt = 0.01110634453604931 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.74 us    (1.6%)
   patch tree reduce : 1240.00 ns (0.4%)
   gen split merge   : 624.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 952.00 ns  (0.3%)
   LB compute        : 279.06 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8584255228465408e-17,-6.928442194964468e-17,-9.587057710203072e-19)
    sum a = (5.0994364980683214e-18,8.606396845189934e-19,-3.401575895956022e-17)
    sum e = 2.592001466700535
    sum de = -1.2976544751935881e-18
Info: CFL hydro = 0.011102452402557346 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011102452402557346 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8794e+04 |  512 |      1 | 2.724e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1467.6800328672923 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.25585762002118, dt = 0.011102452402557346 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.06 us    (1.7%)
   patch tree reduce : 1366.00 ns (0.5%)
   gen split merge   : 891.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 281.91 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1987.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8742331905213795e-17,-6.912049058116487e-17,-1.2894958538456346e-18)
    sum a = (-1.4091657528358946e-16,-1.4109807072726354e-18,-1.0659637235399533e-16)
    sum e = 2.592001466398796
    sum de = 2.846030702774449e-19
Info: CFL hydro = 0.0110982776243261 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0110982776243261 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8314e+04 |  512 |      1 | 2.796e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1429.6362168194114 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.26696007242374, dt = 0.0110982776243261 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.5%)
   patch tree reduce : 1494.00 ns (0.5%)
   gen split merge   : 781.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 896.00 ns  (0.3%)
   LB compute        : 277.12 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.66 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.37 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6448756419429333e-17,-6.908536243077635e-17,-3.0078478770179106e-18)
    sum a = (-1.245351478190715e-16,-5.989935110417566e-17,-8.834729822715382e-17)
    sum e = 2.592001466202262
    sum de = -8.521151449378261e-19
Info: CFL hydro = 0.011094085710438495 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011094085710438495 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9598e+04 |  512 |      1 | 2.612e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.351764176784 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.278058350048067, dt = 0.011094085710438495 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.5%)
   patch tree reduce : 1628.00 ns (0.6%)
   gen split merge   : 819.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 870.00 ns  (0.3%)
   LB compute        : 276.99 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4961664719648214e-17,-7.021531793494073e-17,-4.014854854822447e-18)
    sum a = (-4.632232097900868e-17,-7.919641505094166e-17,3.086008011632391e-17)
    sum e = 2.5920014661493984
    sum de = 8.283982224147057e-19
Info: CFL hydro = 0.011089917206190408 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011089917206190408 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9703e+04 |  512 |      1 | 2.599e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.9340605713437 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.289152435758506, dt = 0.011089917206190408 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.4%)
   patch tree reduce : 1414.00 ns (0.5%)
   gen split merge   : 615.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 911.00 ns  (0.3%)
   LB compute        : 264.77 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1905.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4850425576751203e-17,-7.10701029277283e-17,-3.001993185286489e-18)
    sum a = (5.511606795960411e-17,-6.015695754035822e-17,-4.6486252347488486e-18)
    sum e = 2.592001466268944
    sum de = -8.74138001566438e-19
Info: CFL hydro = 0.011085812894219059 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011085812894219059 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8835e+04 |  512 |      1 | 2.718e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1468.6456109790306 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.3002423529647, dt = 0.011085812894219059 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1631.00 ns (0.5%)
   gen split merge   : 807.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1216.00 ns (0.4%)
   LB compute        : 269.08 us  (89.6%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.50 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.509765625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.611064797193973e-17,-7.167606352193046e-17,-3.0356576627421637e-18)
    sum a = (-1.2283143252522777e-17,1.2365108936762681e-17,8.909669876877579e-17)
    sum e = 2.5920014665780298
    sum de = -7.030373462210693e-19
Info: CFL hydro = 0.011081813734386489 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011081813734386489 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6868e+04 |  512 |      1 | 3.035e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1314.8087496200958 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.311328165858917, dt = 0.011081813734386489 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.6%)
   patch tree reduce : 1405.00 ns (0.5%)
   gen split merge   : 665.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 967.00 ns  (0.3%)
   LB compute        : 276.99 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.53 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5391984561907713e-17,-7.103790212320548e-17,-1.6656597975894804e-18)
    sum a = (1.325677848745821e-16,-9.101118296495069e-17,-1.0682470533152077e-16)
    sum e = 2.592001467082387
    sum de = 4.264810889425402e-19
Info: CFL hydro = 0.011077959951322281 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011077959951322281 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9264e+04 |  512 |      1 | 2.658e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1501.0006705310511 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.322409979593303, dt = 0.011077959951322281 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.3%)
   patch tree reduce : 1187.00 ns (0.4%)
   gen split merge   : 917.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 890.00 ns  (0.3%)
   LB compute        : 286.85 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.792999342747903e-17,-7.263916031174932e-17,-3.957771610441085e-18)
    sum a = (-3.4121143410725806e-17,6.7914424084492e-19,-5.505752104228989e-17)
    sum e = 2.5920014677760927
    sum de = 1.475107877643364e-18
Info: CFL hydro = 0.011074290713649158 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011074290713649158 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9321e+04 |  512 |      1 | 2.650e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1504.9724341268477 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.333487939544625, dt = 0.011074290713649158 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.5%)
   patch tree reduce : 1660.00 ns (0.5%)
   gen split merge   : 793.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1214.00 ns (0.4%)
   LB compute        : 289.67 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6428264998369357e-17,-7.211516540178708e-17,-4.27977965566928e-18)
    sum a = (-2.1897718013863533e-16,-4.5848090948763517e-17,-8.463542366943244e-17)
    sum e = 2.592001468642342
    sum de = 1.1206245892174393e-18
Info: CFL hydro = 0.011070843654858704 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011070843654858704 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8865e+04 |  512 |      1 | 2.714e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1468.9642206423498 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.344562230258273, dt = 0.011070843654858704 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.5%)
   patch tree reduce : 2.19 us    (0.7%)
   gen split merge   : 835.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 995.00 ns  (0.3%)
   LB compute        : 287.09 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.50 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3088163365593264e-17,-7.291140347726044e-17,-5.409735159833673e-18)
    sum a = (-1.5290112925780973e-16,3.872293111162328e-17,-8.355816039085084e-17)
    sum e = 2.5920014696528764
    sum de = -2.8756768559283497e-19
Info: CFL hydro = 0.01106765440955166 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01106765440955166 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9321e+04 |  512 |      1 | 2.650e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1503.993916462219 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.355633073913133, dt = 0.01106765440955166 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.4%)
   patch tree reduce : 1428.00 ns (0.5%)
   gen split merge   : 794.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 890.00 ns  (0.3%)
   LB compute        : 299.11 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.192015236517463e-17,-7.21737123191013e-17,-6.226464656367004e-18)
    sum a = (6.075999078869465e-17,-4.2235746150476315e-17,5.269222558279552e-19)
    sum e = 2.5920014707709633
    sum de = 1.542446996950081e-18
Info: CFL hydro = 0.011064756631571943 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011064756631571943 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8849e+04 |  512 |      1 | 2.716e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1466.8431141961717 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.366700728322684, dt = 0.011064756631571943 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.5%)
   patch tree reduce : 1398.00 ns (0.5%)
   gen split merge   : 771.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 958.00 ns  (0.3%)
   LB compute        : 280.39 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1977.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.351262851612134e-17,-7.298751446976892e-17,-5.515119610999264e-18)
    sum a = (4.32017702861609e-17,-2.0151848939553573e-17,1.1123914289701275e-18)
    sum e = 2.592001471953277
    sum de = -1.0384623933337722e-18
Info: CFL hydro = 0.011062181306273372 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011062181306273372 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9347e+04 |  512 |      1 | 2.646e-02 | 0.0% |   3.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1505.1463190782756 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.377765484954256, dt = 0.011062181306273372 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.5%)
   patch tree reduce : 1615.00 ns (0.5%)
   gen split merge   : 784.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1664.00 ns (0.6%)
   LB compute        : 279.47 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1987.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4071751576472112e-17,-7.302264262015745e-17,-5.6205040621648546e-18)
    sum a = (-2.102683261881455e-16,-6.1122981676042795e-18,4.790308774649254e-17)
    sum e = 2.592001473153165
    sum de = 6.505213034913027e-19
Info: CFL hydro = 0.011059955695358526 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011059955695358526 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7552e+04 |  512 |      1 | 2.917e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1365.2043322424115 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.38882766626053, dt = 0.011059955695358526 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.78 us    (0.8%)
   patch tree reduce : 1399.00 ns (0.2%)
   gen split merge   : 797.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 961.00 ns  (0.2%)
   LB compute        : 552.41 us  (96.7%)
   LB move op cnt    : 0
   LB apply          : 3.79 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.525390625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0307184793167944e-17,-7.280016433436342e-17,-5.043816926619815e-18)
    sum a = (-5.057575452188656e-17,1.5414817859660258e-16,4.143950807500296e-17)
    sum e = 2.592001474322621
    sum de = -1.1519648082658485e-18
Info: CFL hydro = 0.011058103992042441 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011058103992042441 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7294e+04 |  512 |      1 | 2.961e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1344.8930728133246 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.399887621955887, dt = 0.011058103992042441 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.79 us    (1.6%)
   patch tree reduce : 1347.00 ns (0.4%)
   gen split merge   : 1049.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1027.00 ns (0.3%)
   LB compute        : 281.60 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 3.65 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1943.00 ns (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.525390625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0681885063978935e-17,-7.037924930342055e-17,-4.6164244302260294e-18)
    sum a = (5.951586879576754e-17,-1.1551306786095062e-16,2.9940893514490697e-17)
    sum e = 2.592001475415297
    sum de = 5.082197683525802e-21
Info: CFL hydro = 0.011056646938956723 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011056646938956723 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9319e+04 |  512 |      1 | 2.650e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1502.0719050188197 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.41094572594793, dt = 0.011056646938956723 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1461.00 ns (0.5%)
   gen split merge   : 682.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1018.00 ns (0.3%)
   LB compute        : 294.26 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.525390625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1747438959097689e-17,-7.31982833721001e-17,-4.270997618072148e-18)
    sum a = (-3.047659780791578e-17,2.0462147601318924e-17,-4.0982842119952065e-18)
    sum e = 2.592001476388678
    sum de = 8.131516293641283e-19
Info: CFL hydro = 0.01105560172218795 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01105560172218795 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8804e+04 |  512 |      1 | 2.723e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1461.8431942397385 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.422002372886887, dt = 0.01105560172218795 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.4%)
   patch tree reduce : 2.21 us    (0.7%)
   gen split merge   : 1036.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 991.00 ns  (0.3%)
   LB compute        : 288.63 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1756.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.525390625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0875089891115851e-17,-7.239911795076104e-17,-4.019245873621013e-18)
    sum a = (-4.192252014284525e-17,-1.267189478348918e-16,1.2195908345724593e-16)
    sum e = 2.592001477206333
    sum de = -7.775762455794477e-19
Info: CFL hydro = 0.011054981400439385 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011054981400439385 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8553e+04 |  512 |      1 | 2.760e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1442.2297082525206 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.433057974609074, dt = 0.011054981400439385 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.69 us    (1.5%)
   patch tree reduce : 1551.00 ns (0.5%)
   gen split merge   : 820.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1053.00 ns (0.3%)
   LB compute        : 287.57 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.36 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.525390625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.039500516913927e-17,-7.458438163951419e-17,-2.3477313843001113e-18)
    sum a = (-4.770110088175849e-18,-1.263735210227379e-16,4.2832924707081335e-17)
    sum e = 2.592001477841847
    sum de = -6.793204236979489e-19
Info: CFL hydro = 0.011054795177090153 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011054795177090153 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8913e+04 |  512 |      1 | 2.707e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1470.138841197136 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.444112956009512, dt = 0.011054795177090153 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.4%)
   patch tree reduce : 2.30 us    (0.7%)
   gen split merge   : 934.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1134.00 ns (0.4%)
   LB compute        : 299.69 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (68.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0579427958679055e-17,-7.582703995950845e-17,-2.286257121120183e-18)
    sum a = (4.772598332161704e-17,-8.549020866222002e-17,1.0374513748079295e-16)
    sum e = 2.5920014782771243
    sum de = 6.911788849595091e-19
Info: CFL hydro = 0.011055047945291909 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011055047945291909 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9077e+04 |  512 |      1 | 2.684e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1482.817974090055 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.455167751186604, dt = 0.011055047945291909 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.5%)
   patch tree reduce : 2.10 us    (0.7%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 987.00 ns  (0.3%)
   LB compute        : 279.34 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1840.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1320046462703902e-17,-7.661156865151896e-17,-8.284388799961739e-19)
    sum a = (-3.2072001304728205e-17,7.348516326693976e-17,-1.4625019945091466e-17)
    sum e = 2.5920014785055376
    sum de = 7.199780051661553e-19
Info: CFL hydro = 0.011055740938274165 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011055740938274165 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9268e+04 |  512 |      1 | 2.657e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1497.7190010542422 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.466222799131895, dt = 0.011055740938274165 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 2.12 us    (0.7%)
   gen split merge   : 746.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 978.00 ns  (0.3%)
   LB compute        : 282.79 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1972.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0757996056487417e-17,-7.478197748544968e-17,-1.6685871434551914e-18)
    sum a = (1.4212776463552734e-16,1.389581808994289e-16,-2.2370777105762408e-17)
    sum e = 2.5920014785283425
    sum de = 4.743384504624082e-20
Info: CFL hydro = 0.011056870772735115 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011056870772735115 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9420e+04 |  512 |      1 | 2.636e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.6399086640304 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.47727854007017, dt = 0.011056870772735115 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.82 us    (1.5%)
   patch tree reduce : 1706.00 ns (0.5%)
   gen split merge   : 712.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1032.00 ns (0.3%)
   LB compute        : 299.50 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.47 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1982.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3003270335487649e-17,-7.309143524800166e-17,-2.0491421059976032e-18)
    sum a = (7.976614974005563e-17,-1.4307842020541695e-16,1.642519128521036e-16)
    sum e = 2.592001478356729
    sum de = 2.2175322559117583e-18
Info: CFL hydro = 0.011058429259862043 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011058429259862043 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8998e+04 |  512 |      1 | 2.695e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1476.961904252989 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.488335410842904, dt = 0.011058429259862043 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.6%)
   patch tree reduce : 2.10 us    (0.7%)
   gen split merge   : 813.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1062.00 ns (0.4%)
   LB compute        : 280.88 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 3.46 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1945.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.368826926806399e-17,-7.624565041830511e-17,8.342935717275957e-19)
    sum a = (-4.421682746509614e-17,-5.393049288399121e-17,-1.8729561358874629e-16)
    sum e = 2.5920014780118943
    sum de = -3.7100043089738355e-19
Info: CFL hydro = 0.011060405164104146 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011060405164104146 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8787e+04 |  512 |      1 | 2.725e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1460.7529911053482 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.499393840102766, dt = 0.0006061598972344484 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.4%)
   patch tree reduce : 1400.00 ns (0.4%)
   gen split merge   : 764.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1595.00 ns (0.5%)
   LB compute        : 310.61 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.40 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.300619768135336e-17,-7.586655912869555e-17,-1.443181511795455e-18)
    sum a = (6.003323143775277e-17,-1.1506445210703042e-16,-3.236912691009786e-17)
    sum e = 2.5920014214031752
    sum de = 7.284483346386983e-20
Info: CFL hydro = 0.011060722008357483 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011060722008357483 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9538e+04 |  512 |      1 | 2.621e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 83.27106174437743 (tsim/hr)                             [sph::Model][rank=0]
Info: iteration since start : 1932                                                    [SPH][rank=0]
Info: time since start : 1806.752949593 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14991144436454865 max=0.15010556783088766 delta=0.00019412346633901345
Number of particle pairs: 130816
Distance min=0.129058 max=1.974597 mean=0.800556
---------------- t = 17.5, dt = 0.011060722008357483 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.31 us    (1.7%)
   patch tree reduce : 1606.00 ns (0.3%)
   gen split merge   : 532.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 897.00 ns  (0.2%)
   LB compute        : 513.00 us  (95.7%)
   LB move op cnt    : 0
   LB apply          : 4.30 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (77.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3536047283047026e-17,-7.699651463285995e-17,-1.7212793690379868e-18)
    sum a = (9.918689404964792e-17,1.4340609998325994e-17,2.4575068542642685e-18)
    sum e = 2.5920014774443336
    sum de = 1.0672615135404184e-18
Info: CFL hydro = 0.01106291989596932 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01106291989596932 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4085e+04 |  512 |      1 | 3.635e-02 | 0.1% |   1.5% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1095.3907113070757 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.511060722008356, dt = 0.01106291989596932 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.65 us    (1.5%)
   patch tree reduce : 1517.00 ns (0.5%)
   gen split merge   : 688.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 813.00 ns  (0.3%)
   LB compute        : 285.32 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5069976516679518e-17,-7.626321449349938e-17,-1.3934166320783703e-18)
    sum a = (9.724642965891484e-18,6.261958724988748e-17,-8.20388678865469e-17)
    sum e = 2.5920014768910913
    sum de = -1.378969638130001e-18
Info: CFL hydro = 0.01106570316699244 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01106570316699244 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7033e+04 |  512 |      1 | 3.006e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1324.958724086714 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.522123641904326, dt = 0.01106570316699244 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.87 us    (1.6%)
   patch tree reduce : 1236.00 ns (0.4%)
   gen split merge   : 978.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 996.00 ns  (0.3%)
   LB compute        : 278.24 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4625019945091466e-17,-7.533231850820332e-17,-2.7956153017538732e-18)
    sum a = (1.137859338001812e-17,1.9354147191147365e-17,-2.9302732115765726e-17)
    sum e = 2.592001476199709
    sum de = -3.5575383784680614e-19
Info: CFL hydro = 0.011068843165051547 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011068843165051547 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9222e+04 |  512 |      1 | 2.664e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1495.595358519219 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.533189345071317, dt = 0.011068843165051547 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 1155.00 ns (0.4%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 858.00 ns  (0.3%)
   LB compute        : 278.18 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.32 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4783096621839852e-17,-7.532500014353904e-17,-2.6873035047225714e-18)
    sum a = (-6.675812246753621e-18,-1.3204671731048556e-16,-9.039058564142e-17)
    sum e = 2.5920014754821468
    sum de = 6.454391058077769e-19
Info: CFL hydro = 0.011072315803725285 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011072315803725285 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9579e+04 |  512 |      1 | 2.615e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.772171341316 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.54425818823637, dt = 0.011072315803725285 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.5%)
   patch tree reduce : 1544.00 ns (0.5%)
   gen split merge   : 712.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 886.00 ns  (0.3%)
   LB compute        : 298.73 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4507926110463033e-17,-7.73887789788652e-17,-3.992899760829616e-18)
    sum a = (-2.909196321343455e-17,4.0731090375500933e-17,1.5890804297424842e-16)
    sum e = 2.592001474768985
    sum de = -8.724439356719293e-19
Info: CFL hydro = 0.011076091985594694 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011076091985594694 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9749e+04 |  512 |      1 | 2.593e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.4827051401949 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.555330504040096, dt = 0.011076091985594694 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1622.00 ns (0.5%)
   gen split merge   : 601.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 762.00 ns  (0.2%)
   LB compute        : 298.50 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4273738441206162e-17,-7.620027655738659e-17,-8.225841882647522e-19)
    sum a = (3.0491234537244335e-17,4.210987027825075e-17,8.869857973103912e-17)
    sum e = 2.592001474097053
    sum de = -1.616138863361205e-18
Info: CFL hydro = 0.011079148805298804 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011079148805298804 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9456e+04 |  512 |      1 | 2.632e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1515.2219054231805 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.56640659602569, dt = 0.011079148805298804 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.5%)
   patch tree reduce : 1309.00 ns (0.4%)
   gen split merge   : 910.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 782.00 ns  (0.3%)
   LB compute        : 281.49 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.50377757121567e-17,-7.574507427526855e-17,-2.5175174445113414e-19)
    sum a = (2.272205860964771e-17,8.704170197104677e-17,5.186085935693363e-17)
    sum e = 2.592001473490384
    sum de = 1.1722935989999517e-18
Info: CFL hydro = 0.01107123786234966 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01107123786234966 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9688e+04 |  512 |      1 | 2.601e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.6660209920012 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.577485744830987, dt = 0.01107123786234966 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1468.00 ns (0.5%)
   gen split merge   : 714.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 988.00 ns  (0.3%)
   LB compute        : 278.87 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5228053193427905e-17,-7.434433927852591e-17,2.6346112791397757e-20)
    sum a = (2.3011865850353084e-17,1.5948180276392776e-17,5.198966257502491e-18)
    sum e = 2.5920014728848177
    sum de = 2.1921212674941293e-18
Info: CFL hydro = 0.011064111256502931 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011064111256502931 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9814e+04 |  512 |      1 | 2.584e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.3792167112326 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.588556982693337, dt = 0.011064111256502931 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 1442.00 ns (0.5%)
   gen split merge   : 771.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 945.00 ns  (0.3%)
   LB compute        : 280.60 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5655445689821688e-17,-7.491078070354095e-17,-2.5467909031684496e-19)
    sum a = (3.3477127320269417e-17,1.0377441093945005e-16,3.081909727420395e-17)
    sum e = 2.5920014724137714
    sum de = -1.0681085464876727e-18
Info: CFL hydro = 0.01105784774512514 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01105784774512514 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9421e+04 |  512 |      1 | 2.636e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.841884770961 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.59962109394984, dt = 0.01105784774512514 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1277.00 ns (0.5%)
   gen split merge   : 740.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 895.00 ns  (0.3%)
   LB compute        : 266.54 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.44 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1861.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6006727193706993e-17,-7.305484342468027e-17,2.0491421059976033e-19)
    sum a = (1.0704425627144909e-16,3.610002921594635e-17,6.535006910612929e-17)
    sum e = 2.592001472094401
    sum de = 1.2883371127737908e-18
Info: CFL hydro = 0.011052516636347733 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011052516636347733 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9927e+04 |  512 |      1 | 2.569e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1549.3037413748036 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.610678941694964, dt = 0.011052516636347733 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.6%)
   patch tree reduce : 1124.00 ns (0.4%)
   gen split merge   : 699.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 902.00 ns  (0.3%)
   LB compute        : 270.02 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7543583773205197e-17,-7.307240749987454e-17,1.124100812432971e-18)
    sum a = (-8.089134830718825e-17,-1.3014979718950492e-17,6.709476724209296e-18)
    sum e = 2.5920014719385214
    sum de = -2.244637310223896e-19
Info: CFL hydro = 0.011048176326602524 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011048176326602524 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9785e+04 |  512 |      1 | 2.588e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.5291917518416 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.62173145833131, dt = 0.011048176326602524 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.82 us    (1.7%)
   patch tree reduce : 1426.00 ns (0.5%)
   gen split merge   : 940.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 924.00 ns  (0.3%)
   LB compute        : 271.31 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.35 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5678864456747376e-17,-7.316022787584586e-17,8.138021506676197e-19)
    sum a = (2.1592103105483316e-17,-9.536707361312846e-17,9.783189883205701e-17)
    sum e = 2.592001471951651
    sum de = 1.2417503006748043e-18
Info: CFL hydro = 0.011044873562208651 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011044873562208651 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9618e+04 |  512 |      1 | 2.610e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.9780037263192 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.632779634657915, dt = 0.011044873562208651 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.78 us    (1.6%)
   patch tree reduce : 1786.00 ns (0.6%)
   gen split merge   : 657.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1029.00 ns (0.3%)
   LB compute        : 285.49 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.40 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6457538457026467e-17,-7.503958392163223e-17,2.5702096700941368e-18)
    sum a = (5.647728378715965e-17,3.295020506444146e-17,-7.393304718439353e-17)
    sum e = 2.592001472133267
    sum de = 1.3332298589782687e-18
Info: CFL hydro = 0.011042642991052773 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011042642991052773 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9101e+04 |  512 |      1 | 2.681e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1483.3609378696676 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.643824508220124, dt = 0.011042642991052773 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.76 us    (1.5%)
   patch tree reduce : 1424.00 ns (0.4%)
   gen split merge   : 1077.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1228.00 ns (0.4%)
   LB compute        : 306.38 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7130828006139963e-17,-7.367544074821097e-17,6.293793611278353e-19)
    sum a = (-1.8966859333113817e-16,7.646812870409913e-17,-2.0994924548878303e-17)
    sum e = 2.5920014724780476
    sum de = -8.190808599949084e-19
Info: CFL hydro = 0.011041506972925 sink sink = inf                                   [SPH][rank=0]
Info: cfl dt = 0.011041506972925 cfl multiplier : 0.9999999999999997           [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9248e+04 |  512 |      1 | 2.660e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1494.5223649798684 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.654867151211178, dt = 0.011041506972925 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.6%)
   patch tree reduce : 1653.00 ns (0.6%)
   gen split merge   : 1040.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 280.91 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1879.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3559466049972712e-17,-7.253670320644945e-17,7.113450453677395e-19)
    sum a = (1.5754682714669289e-16,9.845835084731912e-17,-6.748117689636679e-17)
    sum e = 2.5920014729771186
    sum de = 1.9651164376299768e-19
Info: CFL hydro = 0.011041473853559063 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011041473853559063 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8724e+04 |  512 |      1 | 2.735e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1453.6268093812396 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.665908658184104, dt = 0.011041473853559063 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.82 us    (1.7%)
   patch tree reduce : 1724.00 ns (0.6%)
   gen split merge   : 750.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1166.00 ns (0.4%)
   LB compute        : 273.56 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 3.38 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.39 us    (70.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7408925863382495e-17,-7.122232491274527e-17,-1.7124973314408541e-19)
    sum a = (-1.5556208664974092e-16,1.7259631224231243e-17,1.711911862267712e-17)
    sum e = 2.5920014736173744
    sum de = -8.504210790433175e-19
Info: CFL hydro = 0.01104253864642698 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01104253864642698 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8793e+04 |  512 |      1 | 2.724e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1459.0047869337775 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.676950132037664, dt = 0.01104253864642698 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.3%)
   patch tree reduce : 1383.00 ns (0.4%)
   gen split merge   : 692.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 984.00 ns  (0.3%)
   LB compute        : 318.91 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.44 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.416542664417486e-17,-7.180486674002173e-17,3.5713619561672516e-19)
    sum a = (-1.3716371788374816e-16,-7.967649977291824e-17,3.388695574146894e-17)
    sum e = 2.5920014743837423
    sum de = 1.3840518358135268e-18
Info: CFL hydro = 0.011044683262014665 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011044683262014665 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8245e+04 |  512 |      1 | 2.806e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1416.5579997862371 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.687992670684093, dt = 0.011044683262014665 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.05 us    (1.7%)
   patch tree reduce : 1819.00 ns (0.6%)
   gen split merge   : 789.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1027.00 ns (0.3%)
   LB compute        : 283.70 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2552459072168176e-17,-7.330366782326569e-17,8.474666281232945e-19)
    sum a = (-5.129295425898572e-17,-8.906157061838726e-17,-1.0386223131542139e-16)
    sum e = 2.5920014752583374
    sum de = 1.0596382170151297e-18
Info: CFL hydro = 0.01104787614331946 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01104787614331946 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9418e+04 |  512 |      1 | 2.637e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1507.9441735659611 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.699037353946107, dt = 0.01104787614331946 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.3%)
   patch tree reduce : 1491.00 ns (0.5%)
   gen split merge   : 676.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 311.47 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1943.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2329980786374151e-17,-7.424041850029317e-17,-8.884494702432466e-19)
    sum a = (7.494005416219807e-19,9.923702484759822e-18,-4.9963939235952994e-17)
    sum e = 2.592001476221736
    sum de = 2.084548083192833e-18
Info: CFL hydro = 0.011052072497224263 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011052072497224263 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8985e+04 |  512 |      1 | 2.697e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1474.7651404381306 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.710085230089426, dt = 0.011052072497224263 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.4%)
   patch tree reduce : 1778.00 ns (0.6%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1015.00 ns (0.3%)
   LB compute        : 298.78 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.47 us    (72.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.290666792191919e-17,-7.345881715414837e-17,-1.0845816432458744e-18)
    sum a = (1.6807063553392342e-16,8.400897165417032e-17,2.2681075767527758e-17)
    sum e = 2.592001477252322
    sum de = -1.4340267797015305e-18
Info: CFL hydro = 0.011057167630152716 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011057167630152716 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8175e+04 |  512 |      1 | 2.817e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1412.3651707765428 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.72113730258665, dt = 0.011057167630152716 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.5%)
   patch tree reduce : 1311.00 ns (0.4%)
   gen split merge   : 659.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1342.00 ns (0.4%)
   LB compute        : 288.86 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.558811673491034e-17,-7.224396861987836e-17,-6.674348573820765e-19)
    sum a = (2.461605138476264e-17,4.8611505445994576e-17,-1.4753823163182746e-17)
    sum e = 2.5920014783270102
    sum de = -1.113848325639405e-18
Info: CFL hydro = 0.011063095957310812 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011063095957310812 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9308e+04 |  512 |      1 | 2.652e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1501.1208860265824 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.732194470216804, dt = 0.011063095957310812 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.5%)
   patch tree reduce : 1265.00 ns (0.4%)
   gen split merge   : 720.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1148.00 ns (0.4%)
   LB compute        : 277.91 us  (90.9%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1986.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.503045734749242e-17,-7.15267688827792e-17,-8.15265823600475e-19)
    sum a = (6.775634740774361e-17,-2.6416369092174818e-17,-7.494005416219807e-19)
    sum e = 2.5920014794224806
    sum de = -2.2996944517954254e-18
Info: CFL hydro = 0.011069832984425508 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011069832984425508 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8801e+04 |  512 |      1 | 2.723e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1462.4941570885258 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.743257566174115, dt = 0.011069832984425508 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.78 us    (1.6%)
   patch tree reduce : 1480.00 ns (0.5%)
   gen split merge   : 1145.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 999.00 ns  (0.3%)
   LB compute        : 290.83 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1936.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6106256953141163e-17,-7.246059221394097e-17,-7.186634100320166e-19)
    sum a = (3.072395853356835e-17,9.681318247078962e-17,3.528037237354731e-17)
    sum e = 2.59200148051635
    sum de = -6.759322919089317e-19
Info: CFL hydro = 0.011077286875871029 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011077286875871029 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9367e+04 |  512 |      1 | 2.644e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1507.427982893159 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.75432739915854, dt = 0.011077286875871029 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.4%)
   patch tree reduce : 1602.00 ns (0.5%)
   gen split merge   : 693.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 893.00 ns  (0.3%)
   LB compute        : 281.67 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6374109099853705e-17,-7.063392839373738e-17,-2.5467909031684496e-19)
    sum a = (-1.611650266367115e-16,3.7092399464422334e-17,5.848837039690302e-18)
    sum e = 2.592001481585573
    sum de = -1.2341270041495156e-18
Info: CFL hydro = 0.011085356107754345 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011085356107754345 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9721e+04 |  512 |      1 | 2.596e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.0106561469554 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.76540468603441, dt = 0.011085356107754345 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.02 us    (1.4%)
   patch tree reduce : 1604.00 ns (0.5%)
   gen split merge   : 752.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 947.00 ns  (0.3%)
   LB compute        : 276.63 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3487746076262797e-17,-7.035583053649486e-17,-1.8076360720764572e-19)
    sum a = (4.791186978408968e-17,6.978207074681553e-17,-8.211205153318968e-17)
    sum e = 2.5920014826066655
    sum de = -7.386127300057499e-19
Info: CFL hydro = 0.011093930213610343 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011093930213610343 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9787e+04 |  512 |      1 | 2.588e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.2837714809577 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.776490042142164, dt = 0.011093930213610343 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.4%)
   patch tree reduce : 1471.00 ns (0.5%)
   gen split merge   : 723.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1567.00 ns (0.5%)
   LB compute        : 303.16 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5121205069329458e-17,-6.966204956632138e-17,-1.501728429109672e-18)
    sum a = (-1.9793249071003992e-17,-2.7560961325667764e-17,-5.814879827648056e-17)
    sum e = 2.592001483558893
    sum de = -1.7194768829262297e-19
Info: CFL hydro = 0.011102891258637915 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011102891258637915 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8408e+04 |  512 |      1 | 2.781e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1435.924379041681 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.787583972355776, dt = 0.011102891258637915 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.4%)
   patch tree reduce : 1523.00 ns (0.5%)
   gen split merge   : 686.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 996.00 ns  (0.3%)
   LB compute        : 293.26 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.86 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4430351445021693e-17,-7.054903536363178e-17,-2.008159263877651e-18)
    sum a = (-2.1240364203806497e-17,2.6572982095990347e-18,-7.543184826763749e-17)
    sum e = 2.5920014844230526
    sum de = -1.2586909596198903e-18
Info: CFL hydro = 0.011112115573780725 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011112115573780725 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9039e+04 |  512 |      1 | 2.689e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1486.3223128610853 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.798686863614414, dt = 0.011112115573780725 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.4%)
   patch tree reduce : 1470.00 ns (0.5%)
   gen split merge   : 723.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1022.00 ns (0.3%)
   LB compute        : 286.09 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1920.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.42166551968248e-17,-7.049341579218327e-17,-3.0341939898093082e-18)
    sum a = (4.6391845443319313e-17,1.694589293107368e-16,-4.3152005406443817e-17)
    sum e = 2.5920014851829327
    sum de = 9.461358020830535e-19
Info: CFL hydro = 0.011121475117733733 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011121475117733733 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9269e+04 |  512 |      1 | 2.657e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1505.557680251112 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.809798979188194, dt = 0.011121475117733733 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.03 us    (1.7%)
   patch tree reduce : 1796.00 ns (0.6%)
   gen split merge   : 816.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 935.00 ns  (0.3%)
   LB compute        : 284.30 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5311482550600664e-17,-6.744604874597826e-17,-3.4249946628817085e-18)
    sum a = (6.265251989087672e-17,5.517607854985118e-17,-1.8677930296168153e-17)
    sum e = 2.592001485825738
    sum de = -8.385626177817573e-20
Info: CFL hydro = 0.011130839330824049 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011130839330824049 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9042e+04 |  512 |      1 | 2.689e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1489.0371175184873 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.820920454305927, dt = 0.011130839330824049 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.91 us    (1.6%)
   patch tree reduce : 1313.00 ns (0.4%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 280.14 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1917.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5845723171092897e-17,-6.75924160392638e-17,-3.675282734399987e-18)
    sum a = (5.996668005908701e-17,-5.649192051648822e-17,5.72281480017145e-17)
    sum e = 2.5920014863439236
    sum de = 6.869437202232376e-19
Info: CFL hydro = 0.011131687910874368 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011131687910874368 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9372e+04 |  512 |      1 | 2.643e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1516.1256335146168 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.832051293636752, dt = 0.011131687910874368 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.5%)
   patch tree reduce : 1373.00 ns (0.5%)
   gen split merge   : 724.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 892.00 ns  (0.3%)
   LB compute        : 276.59 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1951.00 ns (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6473638859287875e-17,-6.881311926526523e-17,-2.5833827264898358e-18)
    sum a = (-1.4478652651805923e-17,-4.6954627686002226e-18,5.807744422100387e-17)
    sum e = 2.5920014866510397
    sum de = 1.418780186650953e-18
Info: CFL hydro = 0.011130540118309584 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011130540118309584 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9553e+04 |  512 |      1 | 2.618e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1530.4323793239234 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.843182981547628, dt = 0.011130540118309584 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.4%)
   patch tree reduce : 1326.00 ns (0.4%)
   gen split merge   : 646.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 301.24 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (69.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.586035990042145e-17,-6.862284178399402e-17,-1.803245053277891e-18)
    sum a = (-1.8375974570120078e-16,-3.426751070401135e-17,7.281333739075913e-17)
    sum e = 2.5920014868156898
    sum de = 8.978549240895584e-19
Info: CFL hydro = 0.011130310623530768 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011130310623530768 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9277e+04 |  512 |      1 | 2.656e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1508.6182970885247 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.854313521665937, dt = 0.011130310623530768 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.6%)
   patch tree reduce : 1383.00 ns (0.5%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 870.00 ns  (0.3%)
   LB compute        : 277.09 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2829093256477853e-17,-6.934882355869032e-17,-1.0099343236702473e-18)
    sum a = (1.0533175894000824e-16,2.6310984641009226e-17,3.4339230677721267e-17)
    sum e = 2.592001486878329
    sum de = -1.2760551350386035e-18
Info: CFL hydro = 0.011131032750178698 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011131032750178698 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9659e+04 |  512 |      1 | 2.604e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1538.5291086441152 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.86544383228947, dt = 0.011131032750178698 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.4%)
   patch tree reduce : 1437.00 ns (0.5%)
   gen split merge   : 642.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 884.00 ns  (0.3%)
   LB compute        : 276.87 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1992.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.552078777999899e-17,-6.884824741565377e-17,-8.262433705968908e-19)
    sum a = (2.110030900004389e-17,7.037339461168913e-17,-9.208259155180088e-17)
    sum e = 2.5920014868548686
    sum de = -3.993760346304026e-19
Info: CFL hydro = 0.011132726304405826 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011132726304405826 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9616e+04 |  512 |      1 | 2.610e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1535.2281599362284 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.876574865039647, dt = 0.011132726304405826 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.4%)
   patch tree reduce : 1219.00 ns (0.4%)
   gen split merge   : 661.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1291.00 ns (0.4%)
   LB compute        : 285.21 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5293918475406398e-17,-6.744019405424683e-17,-2.4501884895999915e-18)
    sum a = (2.8131793769481383e-18,1.7265485915962664e-16,1.3919529591455148e-17)
    sum e = 2.5920014867666152
    sum de = 1.1689054672109345e-19
Info: CFL hydro = 0.011135396914420882 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011135396914420882 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9348e+04 |  512 |      1 | 2.646e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1514.5197837890375 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.887707591344054, dt = 0.011135396914420882 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.21 us    (1.6%)
   patch tree reduce : 1547.00 ns (0.5%)
   gen split merge   : 764.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 988.00 ns  (0.3%)
   LB compute        : 304.20 us  (91.3%)
   LB move op cnt    : 0
   LB apply          : 14.31 us   (4.3%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.44 us    (71.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5333437644593494e-17,-6.504855248196106e-17,-1.839105040132849e-18)
    sum a = (-1.0011522860731148e-17,-4.133997831556879e-17,-1.2664283684238332e-16)
    sum e = 2.5920014866358403
    sum de = 3.1061492269203244e-18
Info: CFL hydro = 0.011139035503789623 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011139035503789623 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9065e+04 |  512 |      1 | 2.686e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1492.7284638014212 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.898842988258476, dt = 0.011139035503789623 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1489.00 ns (0.5%)
   gen split merge   : 875.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1000.00 ns (0.3%)
   LB compute        : 292.57 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.525147196035359e-17,-6.691034445255317e-17,-3.8772695991340365e-18)
    sum a = (-6.540568867757779e-17,-1.1032581098691097e-16,-1.908366043315568e-16)
    sum e = 2.5920014864876113
    sum de = 9.434888241228838e-19
Info: CFL hydro = 0.01114361858196478 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114361858196478 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9255e+04 |  512 |      1 | 2.659e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1508.0629466080027 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.909982023762264, dt = 0.01114361858196478 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.65 us    (1.5%)
   patch tree reduce : 1571.00 ns (0.5%)
   gen split merge   : 725.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 991.00 ns  (0.3%)
   LB compute        : 293.45 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (70.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4048332809546427e-17,-6.83183978139601e-17,-6.399178062443944e-18)
    sum a = (9.429273768041258e-17,-5.1029493131071745e-17,-1.154867217481592e-16)
    sum e = 2.5920014863482916
    sum de = 7.970580033662966e-19
Info: CFL hydro = 0.01114910813453869 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114910813453869 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9252e+04 |  512 |      1 | 2.660e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1508.436378732118 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.92112564234423, dt = 0.01114910813453869 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.4%)
   patch tree reduce : 1654.00 ns (0.5%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 988.00 ns  (0.3%)
   LB compute        : 299.01 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5769612178584415e-17,-6.864626055091971e-17,-7.19834348378301e-18)
    sum a = (8.848488348284223e-17,2.0554651730675387e-16,-5.96710181266502e-17)
    sum e = 2.5920014862407306
    sum de = -1.3196773318222e-18
Info: CFL hydro = 0.01115545155723553 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115545155723553 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9902e+04 |  512 |      1 | 2.573e-02 | 0.0% |   2.2% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1560.1256458078058 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.93227475047877, dt = 0.01115545155723553 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.4%)
   patch tree reduce : 1272.00 ns (0.4%)
   gen split merge   : 1029.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 764.00 ns  (0.2%)
   LB compute        : 293.40 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (70.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.695518725419731e-17,-6.487583907588413e-17,-7.796253876854452e-18)
    sum a = (-9.38946186426759e-17,-1.379599559592215e-16,-2.853576749894948e-17)
    sum e = 2.592001486185745
    sum de = 8.139986623113826e-19
Info: CFL hydro = 0.011162582454389947 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011162582454389947 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9300e+04 |  512 |      1 | 2.653e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1513.8572230114137 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.943430202036005, dt = 0.011162582454389947 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.73 us    (1.5%)
   patch tree reduce : 1606.00 ns (0.5%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 916.00 ns  (0.3%)
   LB compute        : 297.54 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4888481073005444e-17,-6.842378226512568e-17,-7.884806089292207e-18)
    sum a = (2.3594407677629548e-17,6.854673079148554e-17,5.2455110567672934e-17)
    sum e = 2.5920014862003815
    sum de = 4.726443845678996e-19
Info: CFL hydro = 0.011163191921024834 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011163191921024834 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9270e+04 |  512 |      1 | 2.657e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1512.432332873559 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.954592784490394, dt = 0.011163191921024834 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.4%)
   patch tree reduce : 1319.00 ns (0.4%)
   gen split merge   : 658.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 313.85 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.60 us    (72.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5772539524450124e-17,-6.633365731700813e-17,-6.6501979704286504e-18)
    sum a = (2.6108997776275177e-17,-5.606452802009443e-17,-9.184840388254401e-17)
    sum e = 2.5920014862284795
    sum de = -3.2441361879839703e-19
Info: CFL hydro = 0.01115994461912814 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115994461912814 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8984e+04 |  512 |      1 | 2.697e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1490.097865596846 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.96575597641142, dt = 0.01115994461912814 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.5%)
   patch tree reduce : 1386.00 ns (0.5%)
   gen split merge   : 924.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 926.00 ns  (0.3%)
   LB compute        : 282.85 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.616480387045538e-17,-6.753094177608387e-17,-8.43148792971371e-18)
    sum a = (-1.077468192792197e-16,2.5280558896279004e-17,8.618106228652778e-18)
    sum e = 2.5920014863025926
    sum de = -4.2690460541616737e-19
Info: CFL hydro = 0.011156405773989953 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011156405773989953 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8923e+04 |  512 |      1 | 2.706e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1484.8684526593565 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.976915921030546, dt = 0.011156405773989953 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1594.00 ns (0.5%)
   gen split merge   : 709.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 972.00 ns  (0.3%)
   LB compute        : 279.80 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.406589688474069e-17,-6.685472488110466e-17,-7.64037270950535e-18)
    sum a = (-6.09517319428987e-17,2.3172869872967183e-17,1.7524263290491504e-16)
    sum e = 2.592001486456158
    sum de = -1.1350241493207625e-19
Info: CFL hydro = 0.011153010587778896 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011153010587778896 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9521e+04 |  512 |      1 | 2.623e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.2856510582556 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 17.988072326804534, dt = 0.011153010587778896 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.4%)
   patch tree reduce : 1292.00 ns (0.4%)
   gen split merge   : 691.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 949.00 ns  (0.3%)
   LB compute        : 279.35 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1966.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3732179456049653e-17,-6.675373144873764e-17,-4.964778588245622e-18)
    sum a = (-5.968419118304591e-17,-2.201364091014568e-17,6.566622245962605e-17)
    sum e = 2.5920014866879044
    sum de = 1.0926725019580474e-18
Info: CFL hydro = 0.011149800878902204 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011149800878902204 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9456e+04 |  512 |      1 | 2.632e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1525.765909606319 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 17.999225337392314, dt = 0.0007746626076858831 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.91 us    (1.3%)
   patch tree reduce : 1149.00 ns (0.4%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 919.00 ns  (0.3%)
   LB compute        : 288.36 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.31 us    (70.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.358581216276411e-17,-6.68898530314932e-17,-5.4024167951693956e-18)
    sum a = (1.134214792399002e-16,-1.6217496096038177e-17,2.2470306865196576e-16)
    sum e = 2.59200143498227
    sum de = 9.046311876675928e-19
Info: CFL hydro = 0.011149705426705877 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011149705426705877 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9836e+04 |  512 |      1 | 2.581e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 108.04636966554303 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 1978                                                    [SPH][rank=0]
Info: time since start : 1808.6214895550002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.1499220579663971 max=0.1500971428314992 delta=0.0001750848651020931
Number of particle pairs: 130816
Distance min=0.127583 max=1.975699 mean=0.800561
---------------- t = 18, dt = 0.011149705426705877 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 10.10 us   (1.2%)
   patch tree reduce : 1589.00 ns (0.2%)
   gen split merge   : 715.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 896.00 ns  (0.1%)
   LB compute        : 818.56 us  (96.8%)
   LB move op cnt    : 0
   LB apply          : 6.24 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 6.19 us    (82.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.47684598925113e-17,-6.688399833976177e-17,-2.8234250874781263e-18)
    sum a = (-6.323506171815318e-17,-5.084214299566625e-17,1.8727695175885238e-17)
    sum e = 2.5920014866386993
    sum de = 2.473336205982557e-19
Info: CFL hydro = 0.011146621514366191 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011146621514366191 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6733e+04 |  512 |      1 | 3.060e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1311.8371406966867 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.011149705426707, dt = 0.011146621514366191 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.4%)
   patch tree reduce : 1095.00 ns (0.3%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 999.00 ns  (0.3%)
   LB compute        : 298.57 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3369188568701506e-17,-6.784709512958065e-17,-3.849459813409784e-18)
    sum a = (1.2674094866866377e-16,-9.714104520774924e-17,-3.4160662579912905e-17)
    sum e = 2.5920014872027317
    sum de = -1.531435568635775e-18
Info: CFL hydro = 0.011143915631467103 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011143915631467103 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9182e+04 |  512 |      1 | 2.669e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1503.3715082790213 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.022296326941074, dt = 0.011143915631467103 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.6%)
   patch tree reduce : 1329.00 ns (0.4%)
   gen split merge   : 688.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 840.00 ns  (0.3%)
   LB compute        : 280.01 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.39 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5684719148478798e-17,-6.904584326158925e-17,-4.585687298636065e-18)
    sum a = (-1.847447975850125e-17,9.186011326600685e-17,1.0217168907797335e-16)
    sum e = 2.5920014875853052
    sum de = -1.0486267887008238e-18
Info: CFL hydro = 0.011141506383184202 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011141506383184202 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8969e+04 |  512 |      1 | 2.699e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1486.2909007628705 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.033440242572542, dt = 0.011141506383184202 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1754.00 ns (0.6%)
   gen split merge   : 899.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 977.00 ns  (0.3%)
   LB compute        : 297.53 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4853352922616913e-17,-6.695425464053883e-17,-2.639002297938342e-18)
    sum a = (3.901420202526151e-17,7.50864214554836e-17,1.2297734242072179e-17)
    sum e = 2.5920014879891324
    sum de = 2.388632911257127e-18
Info: CFL hydro = 0.011139419372171163 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011139419372171163 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9230e+04 |  512 |      1 | 2.663e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1506.4258561329136 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.044581748955725, dt = 0.011139419372171163 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.98 us    (1.3%)
   patch tree reduce : 1421.00 ns (0.4%)
   gen split merge   : 725.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1520.00 ns (0.5%)
   LB compute        : 300.98 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.537109375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5263181343816433e-17,-6.604531374923561e-17,-3.113232328183502e-18)
    sum a = (2.7350192423336583e-17,-6.953617369409581e-17,-7.300946956376175e-17)
    sum e = 2.592001488389191
    sum de = 3.2864878353466853e-19
Info: CFL hydro = 0.011137677261284692 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137677261284692 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9271e+04 |  512 |      1 | 2.657e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.4170999033033 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.055721168327896, dt = 0.011137677261284692 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.4%)
   patch tree reduce : 1093.00 ns (0.3%)
   gen split merge   : 756.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 970.00 ns  (0.3%)
   LB compute        : 296.24 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5740338719927305e-17,-6.779586657693071e-17,-4.306125768460678e-18)
    sum a = (1.0214973398398052e-16,-1.4683566862405682e-17,9.747476263644027e-17)
    sum e = 2.5920014887677527
    sum de = 2.846030702774449e-19
Info: CFL hydro = 0.011136297299707318 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011136297299707318 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8948e+04 |  512 |      1 | 2.702e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1483.8267362272811 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.06685884558918, dt = 0.011136297299707318 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.5%)
   patch tree reduce : 1242.00 ns (0.4%)
   gen split merge   : 759.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1585.00 ns (0.5%)
   LB compute        : 283.25 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7092772509885722e-17,-6.78485588025135e-17,-2.1881910346188694e-18)
    sum a = (-2.3497805264061087e-17,6.97996348220098e-17,-5.119781551835012e-17)
    sum e = 2.5920014891117473
    sum de = 7.487771253728015e-19
Info: CFL hydro = 0.011135290935617702 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011135290935617702 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8622e+04 |  512 |      1 | 2.749e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1458.1557674568985 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.077995142888888, dt = 0.011135290935617702 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.08 us    (1.7%)
   patch tree reduce : 1281.00 ns (0.4%)
   gen split merge   : 882.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 982.00 ns  (0.3%)
   LB compute        : 287.03 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.599209046437844e-17,-6.654442621933932e-17,-3.5889260313615164e-18)
    sum a = (-5.161496230421392e-17,-5.755747441160697e-17,-1.0935393215949496e-16)
    sum e = 2.5920014894125223
    sum de = 4.506215279392878e-19
Info: CFL hydro = 0.011134663751592196 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011134663751592196 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8710e+04 |  512 |      1 | 2.736e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1464.926026867594 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.089130433824504, dt = 0.011134663751592196 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.73 us    (1.5%)
   patch tree reduce : 1267.00 ns (0.4%)
   gen split merge   : 709.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 953.00 ns  (0.3%)
   LB compute        : 293.27 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.48 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (69.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.545345882508764e-17,-6.795247958074624e-17,-5.150665050718262e-18)
    sum a = (-2.0445754464470944e-16,-1.6726561542085293e-16,2.5271776858681872e-17)
    sum e = 2.5920014896666466
    sum de = -1.0164395367051604e-18
Info: CFL hydro = 0.011134415304180844 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011134415304180844 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9124e+04 |  512 |      1 | 2.677e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1497.2154673658877 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.100265097576095, dt = 0.011134415304180844 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.5%)
   patch tree reduce : 1413.00 ns (0.5%)
   gen split merge   : 699.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1549.00 ns (0.5%)
   LB compute        : 279.34 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2174831455491474e-17,-7.03148476943749e-17,-4.137071544715876e-18)
    sum a = (-9.488113419942046e-17,-1.3519946880785615e-16,-1.484164353915407e-17)
    sum e = 2.5920014898759525
    sum de = -8.571973426213519e-19
Info: CFL hydro = 0.011134538930341446 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011134538930341446 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4771e+04 |  512 |      1 | 3.466e-02 | 0.0% |   1.5% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1156.3723685435382 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.111399512880276, dt = 0.011134538930341446 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.85 us    (1.6%)
   patch tree reduce : 1301.00 ns (0.4%)
   gen split merge   : 682.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 989.00 ns  (0.3%)
   LB compute        : 283.53 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1830.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1877705850121822e-17,-7.173461043924467e-17,-4.3397902459163525e-18)
    sum a = (1.251323263756765e-16,2.4582386907306962e-17,-3.729438632915638e-18)
    sum e = 2.5920014900484802
    sum de = 6.471331717022855e-19
Info: CFL hydro = 0.011128434870193432 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011128434870193432 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8925e+04 |  512 |      1 | 2.705e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1481.603462097982 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.122534051810618, dt = 0.011128434870193432 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.65 us    (1.6%)
   patch tree reduce : 1645.00 ns (0.6%)
   gen split merge   : 815.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 994.00 ns  (0.3%)
   LB compute        : 276.95 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.46 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.44991440728659e-17,-7.048317008165328e-17,-4.527140381321848e-18)
    sum a = (2.0766591571352856e-17,-1.0626485043470357e-16,-1.206007949755561e-16)
    sum e = 2.5920014901343724
    sum de = 1.2332799712022613e-18
Info: CFL hydro = 0.011122401166689439 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011122401166689439 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8768e+04 |  512 |      1 | 2.728e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1468.5685155337535 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.133662486680812, dt = 0.011122401166689439 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.05 us    (1.7%)
   patch tree reduce : 1535.00 ns (0.5%)
   gen split merge   : 678.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 275.44 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1860.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.419470010283197e-17,-7.231715226652114e-17,-6.495780476012402e-18)
    sum a = (2.0948087015026927e-17,-4.955118346888776e-17,6.46533607900901e-17)
    sum e = 2.5920014902074717
    sum de = 4.2012834183813297e-19
Info: CFL hydro = 0.01111685618324131 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01111685618324131 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8879e+04 |  512 |      1 | 2.712e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1476.4238448231963 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.1447848878475, dt = 0.01111685618324131 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.4%)
   patch tree reduce : 1296.00 ns (0.4%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 978.00 ns  (0.3%)
   LB compute        : 292.48 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4305939245728984e-17,-7.274161741704921e-17,-4.71229500732806e-18)
    sum a = (1.1171922761898932e-16,-1.972240730105379e-16,-6.960057530314145e-17)
    sum e = 2.592001490289882
    sum de = 5.759824041329242e-20
Info: CFL hydro = 0.011111889144014477 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011111889144014477 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8532e+04 |  512 |      1 | 2.763e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1448.5436885985562 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.155901744030743, dt = 0.011111889144014477 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 2.13 us    (0.7%)
   gen split merge   : 816.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 287.71 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.607259247568549e-17,-7.562651676770726e-17,-6.188409160112762e-18)
    sum a = (-1.1546623032709925e-16,2.4349662910982948e-17,-7.680184613279017e-17)
    sum e = 2.592001490399963
    sum de = 4.1674021004911577e-19
Info: CFL hydro = 0.01110757750745666 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01110757750745666 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7296e+04 |  512 |      1 | 2.960e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1351.3423892760422 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.167013633174758, dt = 0.01110757750745666 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.42 us    (1.7%)
   patch tree reduce : 2.10 us    (0.6%)
   gen split merge   : 830.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 978.00 ns  (0.3%)
   LB compute        : 306.10 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.66 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3519946880785616e-17,-7.414527975965757e-17,-7.120768818341671e-18)
    sum a = (-3.05614908380214e-17,-8.30370928267543e-17,5.278004595876684e-17)
    sum e = 2.5920014905540256
    sum de = 5.590417451878382e-19
Info: CFL hydro = 0.011103986488783761 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011103986488783761 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8439e+04 |  512 |      1 | 2.777e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1440.1089467334825 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.178121210682214, dt = 0.011103986488783761 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.00 us    (1.6%)
   patch tree reduce : 1038.00 ns (0.3%)
   gen split merge   : 1069.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1018.00 ns (0.3%)
   LB compute        : 298.68 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.32 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3831709215483823e-17,-7.53132907600762e-17,-5.94251210739305e-18)
    sum a = (5.202479072541344e-17,-3.3020461365218523e-17,-2.156282964682621e-17)
    sum e = 2.5920014907648885
    sum de = -8.622795403048777e-19
Info: CFL hydro = 0.011101168422022105 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011101168422022105 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9139e+04 |  512 |      1 | 2.675e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1494.2647658695469 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.189225197170998, dt = 0.011101168422022105 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.12 us    (1.6%)
   patch tree reduce : 1557.00 ns (0.5%)
   gen split merge   : 911.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1276.00 ns (0.4%)
   LB compute        : 291.96 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1985.00 ns (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4702594610532803e-17,-7.563237145943869e-17,-6.378686641383968e-18)
    sum a = (-2.696671011492846e-17,-1.1829990112510736e-16,-7.985799521659232e-18)
    sum e = 2.5920014910408726
    sum de = 1.4145450219146816e-19
Info: CFL hydro = 0.011099162734919791 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011099162734919791 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8422e+04 |  512 |      1 | 2.779e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1437.9506595663117 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.20032636559302, dt = 0.011099162734919791 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.77 us    (1.6%)
   patch tree reduce : 1264.00 ns (0.4%)
   gen split merge   : 805.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 280.92 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3909283880925162e-17,-7.742537080218659e-17,-6.515540060605951e-18)
    sum a = (-1.3331133072447265e-16,-1.0019719429155138e-16,5.0379622348883936e-17)
    sum e = 2.5920014913852887
    sum de = 1.5161889755851976e-19
Info: CFL hydro = 0.011097994375712279 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011097994375712279 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8653e+04 |  512 |      1 | 2.745e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1455.660141605732 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.21142552832794, dt = 0.011097994375712279 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.20 us    (1.7%)
   patch tree reduce : 1252.00 ns (0.4%)
   gen split merge   : 1169.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 1187.00 ns (0.4%)
   LB compute        : 281.04 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1945.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1969917244891715e-17,-7.855093528755242e-17,-5.520974302730685e-18)
    sum a = (-7.121647022101385e-17,-2.4542867738119866e-17,2.8418673664321046e-17)
    sum e = 2.592001491794606
    sum de = 1.8759662199314617e-18
Info: CFL hydro = 0.011097674272912979 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011097674272912979 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9131e+04 |  512 |      1 | 2.676e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1492.8579006730884 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.222523522703653, dt = 0.011097674272912979 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.5%)
   patch tree reduce : 1071.00 ns (0.4%)
   gen split merge   : 630.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 980.00 ns  (0.3%)
   LB compute        : 279.19 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1860.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.146495008305659e-17,-7.848067898677535e-17,-5.497921454038213e-18)
    sum a = (-8.852293897909646e-18,-1.1931861748637473e-17,-9.285541086034855e-18)
    sum e = 2.5920014922599
    sum de = -1.0871667878008945e-18
Info: CFL hydro = 0.01109819928713801 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01109819928713801 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9008e+04 |  512 |      1 | 2.694e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1483.2013547958513 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.233621196976568, dt = 0.01109819928713801 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.16 us    (1.8%)
   patch tree reduce : 1579.00 ns (0.5%)
   gen split merge   : 806.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1001.00 ns (0.3%)
   LB compute        : 276.80 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.158350759061788e-17,-7.829479252430271e-17,-5.85432581318851e-18)
    sum a = (-9.524997977850002e-17,1.3546585728163585e-16,1.973031113489121e-17)
    sum e = 2.592001492767813
    sum de = 5.370188885592264e-19
Info: CFL hydro = 0.011099233148275003 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011099233148275003 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9023e+04 |  512 |      1 | 2.692e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1484.4321275838208 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.244719396263704, dt = 0.011099233148275003 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.3%)
   patch tree reduce : 1398.00 ns (0.4%)
   gen split merge   : 833.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1177.00 ns (0.4%)
   LB compute        : 286.40 us  (90.4%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.915652283629117e-18,-7.62032039032523e-17,-5.36582497184801e-18)
    sum a = (-8.760375237726325e-17,-1.682287122106718e-16,-2.3064558075935882e-17)
    sum e = 2.592001493296636
    sum de = -9.656175598699024e-20
Info: CFL hydro = 0.011101028241895752 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011101028241895752 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9106e+04 |  512 |      1 | 2.680e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1491.0498673015736 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.25581862941198, dt = 0.011101028241895752 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.29 us    (1.8%)
   patch tree reduce : 1136.00 ns (0.4%)
   gen split merge   : 996.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1060.00 ns (0.4%)
   LB compute        : 280.31 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.349210858614066e-18,-7.95037863668413e-17,-6.066558388452547e-18)
    sum a = (-5.421444543296516e-18,9.338233311617649e-17,1.5473950246147617e-17)
    sum e = 2.5920014938272002
    sum de = 1.2705494208814505e-19
Info: CFL hydro = 0.011103547705558874 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011103547705558874 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8867e+04 |  512 |      1 | 2.714e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1472.6652861459577 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.266919657653876, dt = 0.011103547705558874 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.4%)
   patch tree reduce : 1339.00 ns (0.4%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1206.00 ns (0.4%)
   LB compute        : 275.75 us  (90.3%)
   LB move op cnt    : 0
   LB apply          : 15.61 us   (5.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (70.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.468500202641784e-18,-7.728193085476675e-17,-5.656364049019813e-18)
    sum a = (1.8198723777951287e-16,1.1988066789259121e-16,-1.5880851321481426e-17)
    sum e = 2.5920014943380387
    sum de = 1.548376227580861e-18
Info: CFL hydro = 0.011106738728324659 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011106738728324659 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9093e+04 |  512 |      1 | 2.682e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1490.6200090584011 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.278023205359435, dt = 0.011106738728324659 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.4%)
   patch tree reduce : 1479.00 ns (0.5%)
   gen split merge   : 637.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 295.81 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.78 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2549531726302465e-17,-7.56221257489087e-17,-5.98239719481336e-18)
    sum a = (-6.485827500068986e-17,-3.8980537547805836e-17,-7.242253671768673e-17)
    sum e = 2.592001494808008
    sum de = 1.9820570965750628e-19
Info: CFL hydro = 0.011110538006866634 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011110538006866634 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9292e+04 |  512 |      1 | 2.654e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1506.60769725825 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 18.28912994408776, dt = 0.011110538006866634 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.3%)
   patch tree reduce : 1838.00 ns (0.6%)
   gen split merge   : 752.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 965.00 ns  (0.3%)
   LB compute        : 292.47 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.55 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0490143909774873e-17,-7.674329921547596e-17,-6.862979423042509e-18)
    sum a = (-7.073638549903727e-17,5.898016450234244e-17,1.394441203131369e-17)
    sum e = 2.592001495218282
    sum de = -8.978549240895584e-20
Info: CFL hydro = 0.01111487277175529 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01111487277175529 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8897e+04 |  512 |      1 | 2.709e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1476.2575216328971 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.30024048209463, dt = 0.01111487277175529 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.82 us    (1.6%)
   patch tree reduce : 1324.00 ns (0.5%)
   gen split merge   : 911.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 966.00 ns  (0.3%)
   LB compute        : 274.96 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.74 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1860.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.742938877552177e-18,-7.574507427526855e-17,-6.241101385695558e-18)
    sum a = (1.5462533597271343e-16,-1.8805269841326578e-17,1.4098646566613332e-16)
    sum e = 2.592001495554622
    sum de = 1.4348738126487848e-18
Info: CFL hydro = 0.011119662100973444 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011119662100973444 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8995e+04 |  512 |      1 | 2.696e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1484.4499721692696 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.311355354866386, dt = 0.011119662100973444 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1382.00 ns (0.5%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1007.00 ns (0.3%)
   LB compute        : 287.05 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2570754983828869e-17,-7.632761610254502e-17,-4.018514037154586e-18)
    sum a = (-6.189287363872475e-17,6.205973235307028e-19,-3.9431165852008703e-17)
    sum e = 2.592001495809299
    sum de = -4.421511984667448e-19
Info: CFL hydro = 0.011124818264153832 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011124818264153832 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9103e+04 |  512 |      1 | 2.680e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1493.5556021250384 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.32247501696736, dt = 0.011124818264153832 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.5%)
   patch tree reduce : 1306.00 ns (0.4%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 929.00 ns  (0.3%)
   LB compute        : 295.27 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0716281377901038e-17,-7.616661207993092e-17,-5.362165789515872e-18)
    sum a = (-1.5414689788278632e-16,-1.8020741149316065e-17,1.6439242545365772e-17)
    sum e = 2.5920014959812296
    sum de = 1.4907779871675686e-19
Info: CFL hydro = 0.011130248363904884 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011130248363904884 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9280e+04 |  512 |      1 | 2.656e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1508.0999186160182 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.333599835231514, dt = 0.011130248363904884 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1370.00 ns (0.4%)
   gen split merge   : 750.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1530.00 ns (0.5%)
   LB compute        : 303.27 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.616642555719923e-18,-7.649447481689054e-17,-4.977951644641321e-18)
    sum a = (4.690779015215085e-17,-1.4944686113627092e-16,-3.3260503726206814e-17)
    sum e = 2.5920014960774975
    sum de = 4.811147140404426e-19
Info: CFL hydro = 0.011135855748910371 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011135855748910371 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8707e+04 |  512 |      1 | 2.737e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1463.9701097082634 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.34473008359542, dt = 0.011135855748910371 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.71 us    (1.6%)
   patch tree reduce : 1129.00 ns (0.4%)
   gen split merge   : 740.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1032.00 ns (0.3%)
   LB compute        : 279.27 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1781.00 ns (64.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0157890154016691e-17,-7.898271880274476e-17,-5.846641530291019e-18)
    sum a = (-2.9867709867847924e-17,-4.97765891005475e-17,-8.980365279534497e-17)
    sum e = 2.592001496111791
    sum de = 1.2163393122571753e-18
Info: CFL hydro = 0.011141541372426497 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011141541372426497 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9491e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1526.1457603535066 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.35586593934433, dt = 0.011141541372426497 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1346.00 ns (0.4%)
   gen split merge   : 722.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1557.00 ns (0.5%)
   LB compute        : 289.15 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.42 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.529296875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.262122319109167e-18,-7.895637268995337e-17,-6.8573076904276944e-18)
    sum a = (2.2203918391416889e-16,-1.2189468184820029e-17,-3.025704686798747e-17)
    sum e = 2.5920014961042703
    sum de = -4.0318768289304696e-19
Info: CFL hydro = 0.01114720576695499 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114720576695499 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9458e+04 |  512 |      1 | 2.631e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1524.2970954473583 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.367007480716758, dt = 0.01114720576695499 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1153.00 ns (0.4%)
   gen split merge   : 733.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 982.00 ns  (0.3%)
   LB compute        : 288.15 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3462863636404254e-17,-7.863143729885946e-17,-6.879262784420525e-18)
    sum a = (7.6216376959648e-17,-3.892199063049162e-17,-1.565251834395598e-17)
    sum e = 2.5920014960805275
    sum de = 1.5754812818929986e-18
Info: CFL hydro = 0.011148887941277597 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011148887941277597 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9143e+04 |  512 |      1 | 2.675e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1500.4391309508767 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.378154686483715, dt = 0.011148887941277597 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1027.00 ns (0.3%)
   gen split merge   : 665.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1152.00 ns (0.4%)
   LB compute        : 288.79 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3342842455910109e-17,-7.976432014888957e-17,-7.094788623783488e-18)
    sum a = (1.1417234345445505e-16,7.684868366664155e-17,-7.154433295797347e-17)
    sum e = 2.592001496033375
    sum de = 1.111307226797642e-18
Info: CFL hydro = 0.011146709615072869 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011146709615072869 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9536e+04 |  512 |      1 | 2.621e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.4654861657116 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.389303574424993, dt = 0.011146709615072869 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.4%)
   patch tree reduce : 1568.00 ns (0.5%)
   gen split merge   : 1134.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 974.00 ns  (0.3%)
   LB compute        : 291.40 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4831397828624083e-17,-7.780007107299757e-17,-7.983969930493161e-18)
    sum a = (-3.067858467264983e-17,-7.823039091525708e-17,1.199860523437568e-16)
    sum e = 2.592001495994439
    sum de = -7.386127300057499e-19
Info: CFL hydro = 0.011143823989171603 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011143823989171603 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9440e+04 |  512 |      1 | 2.634e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.636150583573 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.400450284040065, dt = 0.011143823989171603 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.3%)
   patch tree reduce : 1245.00 ns (0.4%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1210.00 ns (0.4%)
   LB compute        : 317.76 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.53 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.82 us    (73.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3578493798099832e-17,-7.962966223906686e-17,-5.7837035941782355e-18)
    sum a = (1.4054187501277848e-16,-7.188390507839592e-17,5.657388620072812e-17)
    sum e = 2.5920014960203965
    sum de = 3.7269449679189215e-20
Info: CFL hydro = 0.011140439822986422 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011140439822986422 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8742e+04 |  512 |      1 | 2.732e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1468.5241857662716 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.411594108029238, dt = 0.011140439822986422 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.45 us    (1.8%)
   patch tree reduce : 1319.00 ns (0.4%)
   gen split merge   : 631.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 983.00 ns  (0.3%)
   LB compute        : 285.49 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.53 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1956.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6338980949465177e-17,-8.027367832952326e-17,-5.347894978420531e-18)
    sum a = (-3.2353026507836446e-17,-1.0271763908192844e-16,4.7736229032147025e-17)
    sum e = 2.5920014961361435
    sum de = 6.030874584450618e-19
Info: CFL hydro = 0.011136868773672367 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011136868773672367 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9184e+04 |  512 |      1 | 2.669e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1502.7103795872933 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.422734547852226, dt = 0.011136868773672367 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.79 us    (1.6%)
   patch tree reduce : 1394.00 ns (0.5%)
   gen split merge   : 745.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 973.00 ns  (0.3%)
   LB compute        : 285.25 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1850.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.517578125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5033384693358132e-17,-8.16056206984217e-17,-5.001004493333794e-18)
    sum a = (-1.8147202490714774e-16,-7.878073193801072e-17,5.205699152993626e-17)
    sum e = 2.5920014963605533
    sum de = 1.3095129364551483e-18
Info: CFL hydro = 0.011133155586130218 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011133155586130218 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9220e+04 |  512 |      1 | 2.664e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1505.0265022887315 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.433871416625898, dt = 0.011133155586130218 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.5%)
   patch tree reduce : 1547.00 ns (0.5%)
   gen split merge   : 698.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 280.20 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1946.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2035782526870208e-17,-8.25511534130463e-17,-4.325153516587798e-18)
    sum a = (7.680184613279017e-17,2.4790228463772433e-17,3.989972414963905e-18)
    sum e = 2.5920014967012444
    sum de = 7.758821796849391e-19
Info: CFL hydro = 0.011129348569287328 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011129348569287328 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9211e+04 |  512 |      1 | 2.665e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1503.8136471266994 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.445004572212028, dt = 0.011129348569287328 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.5%)
   patch tree reduce : 1128.00 ns (0.4%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 990.00 ns  (0.3%)
   LB compute        : 276.47 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1979.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4352776779580356e-17,-8.169051372852731e-17,-4.556413839978957e-18)
    sum a = (1.4444695439763677e-16,2.471622150110493e-17,6.751923239262103e-17)
    sum e = 2.5920014971570753
    sum de = -1.0079692072326174e-18
Info: CFL hydro = 0.011125498893734292 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011125498893734292 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9149e+04 |  512 |      1 | 2.674e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1498.4671434493532 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.456133920781316, dt = 0.011125498893734292 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.4%)
   patch tree reduce : 1170.00 ns (0.4%)
   gen split merge   : 781.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 896.00 ns  (0.3%)
   LB compute        : 273.55 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1989.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6327271566002333e-17,-8.12309204276107e-17,-3.32839224931325e-18)
    sum a = (-4.818411294960079e-17,4.643795114070426e-17,-2.861187849145797e-17)
    sum e = 2.592001497716461
    sum de = -2.727446090158847e-19
Info: CFL hydro = 0.011121659838213574 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011121659838213574 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9053e+04 |  512 |      1 | 2.687e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1490.4410271191334 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.46725941967505, dt = 0.011121659838213574 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1350.00 ns (0.5%)
   gen split merge   : 648.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 992.00 ns  (0.3%)
   LB compute        : 281.97 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4831397828624083e-17,-8.047859254012302e-17,-4.354426975244907e-18)
    sum a = (2.0233814623793477e-17,-9.773822376435426e-17,-6.736408306173835e-17)
    sum e = 2.592001498357722
    sum de = 9.147955830346444e-20
Info: CFL hydro = 0.01111788590230537 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01111788590230537 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8696e+04 |  512 |      1 | 2.739e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1462.0188506106288 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.478381079513262, dt = 0.01111788590230537 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.10 us    (1.7%)
   patch tree reduce : 1207.00 ns (0.4%)
   gen split merge   : 773.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1004.00 ns (0.3%)
   LB compute        : 282.83 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5476877592013327e-17,-8.222036333022099e-17,-5.444863310222203e-18)
    sum a = (8.383918559395909e-18,1.5899586335021976e-16,-4.969462341630759e-17)
    sum e = 2.5920014990514226
    sum de = -3.6761229910836635e-19
Info: CFL hydro = 0.011114231778019732 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011114231778019732 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.3340e+04 |  512 |      1 | 3.838e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1042.8592170241864 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.489498965415567, dt = 0.010501034584432745 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.01 us    (1.6%)
   patch tree reduce : 994.00 ns  (0.3%)
   gen split merge   : 1051.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 965.00 ns  (0.3%)
   LB compute        : 304.42 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5466631881483338e-17,-7.956233328415551e-17,-5.687101180609777e-18)
    sum a = (-4.127557670652315e-17,-1.452666112400358e-16,-1.6396064193846538e-17)
    sum e = 2.592001494269067
    sum de = 2.22769665127881e-19
Info: CFL hydro = 0.011110946855742803 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011110946855742803 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7849e+04 |  512 |      1 | 2.869e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1317.885673454732 (tsim/hr)                             [sph::Model][rank=0]
Info: iteration since start : 2023                                                    [SPH][rank=0]
Info: time since start : 1810.6557409860002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14990988709859013 max=0.15010387745991854 delta=0.00019399036132841663
Number of particle pairs: 130816
Distance min=0.127638 max=1.976665 mean=0.800556
---------------- t = 18.5, dt = 0.011110946855742803 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 8.89 us    (1.6%)
   patch tree reduce : 1770.00 ns (0.3%)
   gen split merge   : 647.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 753.00 ns  (0.1%)
   LB compute        : 525.82 us  (95.9%)
   LB move op cnt    : 0
   LB apply          : 4.12 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (78.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4633801982688597e-17,-8.246626038294069e-17,-5.717838312199741e-18)
    sum a = (-6.164990393187075e-17,-2.387543288073779e-17,5.0528916988035185e-17)
    sum e = 2.5920015003184895
    sum de = -7.775762455794477e-19
Info: CFL hydro = 0.011107670767874674 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011107670767874674 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4943e+04 |  512 |      1 | 3.426e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1167.419430252198 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.511110946855744, dt = 0.011107670767874674 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (0.7%)
   patch tree reduce : 1163.00 ns (0.2%)
   gen split merge   : 858.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 902.00 ns  (0.1%)
   LB compute        : 612.57 us  (97.3%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (0.5%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1956.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.385512798240951e-17,-8.232282043552086e-17,-4.8081655844300904e-18)
    sum a = (9.824172725325652e-18,9.313058137172536e-17,-7.675939961773737e-17)
    sum e = 2.5920015009882826
    sum de = -1.0203570640862115e-18
Info: CFL hydro = 0.011104679316685894 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011104679316685894 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.3616e+04 |  512 |      1 | 3.760e-02 | 0.0% |   1.5% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1063.4032157154154 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.52221861762362, dt = 0.011104679316685894 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.86 us    (0.8%)
   patch tree reduce : 1498.00 ns (0.2%)
   gen split merge   : 720.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 936.00 ns  (0.1%)
   LB compute        : 619.21 us  (97.2%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (0.5%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.429715720813185e-17,-8.040540889348025e-17,-6.614337983573693e-18)
    sum a = (1.7819339753755158e-16,7.262745092828649e-17,-7.397037084418135e-17)
    sum e = 2.5920015015213553
    sum de = 1.0897078866426574e-18
Info: CFL hydro = 0.011102011043002851 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011102011043002851 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7164e+04 |  512 |      1 | 2.983e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1340.1264424280507 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.533323296940303, dt = 0.011102011043002851 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.83 us    (1.6%)
   patch tree reduce : 1090.00 ns (0.4%)
   gen split merge   : 720.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 856.00 ns  (0.3%)
   LB compute        : 290.83 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1951.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7274267953559796e-17,-7.991654213390653e-17,-7.184438590920882e-18)
    sum a = (7.65676584635333e-17,8.777353843747448e-17,-6.622680919290969e-17)
    sum e = 2.5920015019274496
    sum de = -1.977398415365164e-18
Info: CFL hydro = 0.011099710536456881 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011099710536456881 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9088e+04 |  512 |      1 | 2.682e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1490.023266204843 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.544425307983307, dt = 0.011099710536456881 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.5%)
   patch tree reduce : 1155.00 ns (0.4%)
   gen split merge   : 736.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 995.00 ns  (0.3%)
   LB compute        : 275.87 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1993.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.769580575822216e-17,-7.905297510352183e-17,-7.933107296076436e-18)
    sum a = (4.005780082638744e-17,7.698919626819567e-17,-4.773183801334846e-17)
    sum e = 2.592001502182306
    sum de = -4.396100996249819e-19
Info: CFL hydro = 0.011097641979535673 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011097641979535673 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9543e+04 |  512 |      1 | 2.620e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1525.2282589280958 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.555525018519763, dt = 0.011097641979535673 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.5%)
   patch tree reduce : 1137.00 ns (0.4%)
   gen split merge   : 912.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 293.37 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.772800656274498e-17,-7.836504882507977e-17,-8.493694029360067e-18)
    sum a = (-3.959528017960512e-17,6.23641763231042e-17,8.592638319621093e-17)
    sum e = 2.5920015022715246
    sum de = -1.2951133763518252e-18
Info: CFL hydro = 0.011095338770365617 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011095338770365617 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9466e+04 |  512 |      1 | 2.630e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.9575124047342 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.5666226604993, dt = 0.011095338770365617 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.5%)
   patch tree reduce : 1207.00 ns (0.4%)
   gen split merge   : 758.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 931.00 ns  (0.3%)
   LB compute        : 276.48 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1940.00 ns (64.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7019588863242952e-17,-7.767712254663772e-17,-6.819984030639881e-18)
    sum a = (1.1508567536455683e-16,-4.447223839187941e-17,-8.386845905261619e-17)
    sum e = 2.5920015021904543
    sum de = -8.775261333554552e-19
Info: CFL hydro = 0.011093538851098862 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011093538851098862 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8161e+04 |  512 |      1 | 2.819e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1416.7766521441463 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.577717999269666, dt = 0.011093538851098862 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.47 us    (1.9%)
   patch tree reduce : 1097.00 ns (0.4%)
   gen split merge   : 812.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 925.00 ns  (0.3%)
   LB compute        : 274.40 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.36 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1905.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.918582480386899e-17,-7.880415070493641e-17,-8.772523723069026e-18)
    sum a = (-9.576519265086514e-17,-1.3646115487597755e-16,1.190434469749979e-16)
    sum e = 2.592001501958301
    sum de = 1.6635727084074459e-18
Info: CFL hydro = 0.01109227961848051 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01109227961848051 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9714e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.720658747846 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.588811538120765, dt = 0.01109227961848051 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.08 us    (1.7%)
   patch tree reduce : 1214.00 ns (0.4%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 992.00 ns  (0.3%)
   LB compute        : 279.20 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.34 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6996170096317265e-17,-8.052250272810868e-17,-6.116689186402846e-18)
    sum a = (1.6598343793167157e-16,-3.838335899120082e-17,-9.498944599645175e-17)
    sum e = 2.5920015015999525
    sum de = 1.302736672877114e-18
Info: CFL hydro = 0.011091590996164944 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011091590996164944 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9311e+04 |  512 |      1 | 2.651e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1506.121013041421 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.599903817739246, dt = 0.011091590996164944 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.81 us    (1.6%)
   patch tree reduce : 1322.00 ns (0.4%)
   gen split merge   : 854.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 931.00 ns  (0.3%)
   LB compute        : 278.17 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1961.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.014599424782215e-17,-8.028246036712039e-17,-8.274143089431751e-18)
    sum a = (4.515723732445576e-17,-2.987766284379134e-16,1.2798063390301318e-16)
    sum e = 2.5920015011517985
    sum de = -4.87890977618477e-19
Info: CFL hydro = 0.011091495204309776 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011091495204309776 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8507e+04 |  512 |      1 | 2.767e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1443.2819604895813 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.610995408735413, dt = 0.011091495204309776 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.88 us    (1.6%)
   patch tree reduce : 1123.00 ns (0.4%)
   gen split merge   : 716.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 981.00 ns  (0.3%)
   LB compute        : 295.10 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.34 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1930.00 ns (64.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0096229368105066e-17,-8.488717541388358e-17,-5.936657415661628e-18)
    sum a = (-5.925533501371927e-17,3.848874344236641e-17,1.2845193658739262e-17)
    sum e = 2.592001500659399
    sum de = 2.202285662861181e-20
Info: CFL hydro = 0.011092006197018826 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011092006197018826 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9113e+04 |  512 |      1 | 2.679e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1490.5816122666345 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.62208690393972, dt = 0.011092006197018826 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1134.00 ns (0.4%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 947.00 ns  (0.3%)
   LB compute        : 282.53 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8872598796237926e-17,-8.299025529290294e-17,-6.3450221639282934e-18)
    sum a = (-1.587170336565108e-17,1.0498633212785435e-16,7.330659516913141e-17)
    sum e = 2.5920015001742533
    sum de = -1.4399560103323106e-18
Info: CFL hydro = 0.011093129417756465 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011093129417756465 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8748e+04 |  512 |      1 | 2.731e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1462.198432059628 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.63317891013674, dt = 0.011093129417756465 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.92 us    (1.6%)
   patch tree reduce : 1244.00 ns (0.4%)
   gen split merge   : 765.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 912.00 ns  (0.3%)
   LB compute        : 288.42 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1941.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8691103352563855e-17,-8.148559951792755e-17,-4.851343935949326e-18)
    sum a = (4.464641547088921e-17,2.673252244567159e-17,2.726529939323097e-17)
    sum e = 2.5920014997494887
    sum de = 4.1674021004911577e-19
Info: CFL hydro = 0.01109486156666797 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01109486156666797 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8751e+04 |  512 |      1 | 2.730e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1462.5767395894336 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.644272039554494, dt = 0.01109486156666797 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 1045.00 ns (0.3%)
   gen split merge   : 727.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 961.00 ns  (0.3%)
   LB compute        : 284.17 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.963370872132275e-17,-8.162903946534738e-17,-4.997345311001655e-18)
    sum a = (2.6395877671114843e-17,-3.895711878088015e-17,4.44956571588051e-19)
    sum e = 2.592001499437042
    sum de = 1.3891340334970526e-19
Info: CFL hydro = 0.011097190632215408 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011097190632215408 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8544e+04 |  512 |      1 | 2.761e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1446.6031597711922 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.655366901121162, dt = 0.011097190632215408 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.16 us    (1.7%)
   patch tree reduce : 1381.00 ns (0.5%)
   gen split merge   : 786.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 919.00 ns  (0.3%)
   LB compute        : 281.95 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9979135533476634e-17,-8.236380327764082e-17,-5.036132643722324e-18)
    sum a = (4.7756720453207003e-17,-1.2511476230048224e-16,8.071863490111131e-17)
    sum e = 2.5920014992827847
    sum de = -1.4399560103323106e-19
Info: CFL hydro = 0.011100095943980155 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011100095943980155 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8835e+04 |  512 |      1 | 2.718e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1469.665548637661 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.66646409175338, dt = 0.011100095943980155 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.94 us    (1.6%)
   patch tree reduce : 1359.00 ns (0.4%)
   gen split merge   : 947.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 934.00 ns  (0.3%)
   LB compute        : 294.59 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.044165618025895e-17,-8.419485811664296e-17,-3.9603330380735824e-18)
    sum a = (-3.179097610161996e-17,-4.220061800008778e-17,9.296665000324556e-17)
    sum e = 2.5920014993233798
    sum de = -2.659683454378503e-19
Info: CFL hydro = 0.011103548401708782 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011103548401708782 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7653e+04 |  512 |      1 | 2.900e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1377.8031215083433 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.67756418769736, dt = 0.011103548401708782 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.19 us    (1.7%)
   patch tree reduce : 1079.00 ns (0.4%)
   gen split merge   : 802.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 910.00 ns  (0.3%)
   LB compute        : 281.53 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1993.00 ns (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9762511939414028e-17,-8.397237983084893e-17,-2.7815274497751396e-18)
    sum a = (5.362897625982299e-18,-6.091221277371162e-17,-1.1482221423664285e-16)
    sum e = 2.592001499582413
    sum de = 7.148958074826295e-19
Info: CFL hydro = 0.011107510806792424 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011107510806792424 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8781e+04 |  512 |      1 | 2.726e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1466.291690072453 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.68866773609907, dt = 0.011107510806792424 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.56 us    (1.5%)
   patch tree reduce : 1049.00 ns (0.3%)
   gen split merge   : 743.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 955.00 ns  (0.3%)
   LB compute        : 292.38 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1958.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9762511939414028e-17,-8.505842514702766e-17,-5.11919608266187e-18)
    sum a = (-6.941322516773596e-17,-2.2774750835230506e-17,6.847647449070848e-17)
    sum e = 2.5920015000684624
    sum de = 9.656175598699024e-20
Info: CFL hydro = 0.011111938297232173 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011111938297232173 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9392e+04 |  512 |      1 | 2.640e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1514.475442886308 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.699775246905862, dt = 0.011111938297232173 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.3%)
   patch tree reduce : 1091.00 ns (0.3%)
   gen split merge   : 816.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 910.00 ns  (0.3%)
   LB compute        : 301.13 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.39 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (64.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.525390625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.87847784202666e-17,-8.508623493275192e-17,-3.4526214894893547e-18)
    sum a = (-2.0925839186447526e-16,5.761016663718977e-18,4.377553007584023e-17)
    sum e = 2.5920015007732093
    sum de = -1.0503208545953324e-19
Info: CFL hydro = 0.011116779366720935 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011116779366720935 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9322e+04 |  512 |      1 | 2.650e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.615321290185 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.710887185203095, dt = 0.011116779366720935 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.76 us    (1.6%)
   patch tree reduce : 1104.00 ns (0.4%)
   gen split merge   : 659.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 971.00 ns  (0.3%)
   LB compute        : 280.94 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1924.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.525390625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.572277464473304e-17,-8.496035906052634e-17,-3.284665020444194e-18)
    sum a = (1.275034765269023e-16,-1.871159477362383e-17,-1.1742169736539408e-16)
    sum e = 2.5920015016723905
    sum de = 1.892271604166107e-18
Info: CFL hydro = 0.011121975915004549 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011121975915004549 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9037e+04 |  512 |      1 | 2.690e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1488.013054233524 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.722003964569815, dt = 0.011121975915004549 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.4%)
   patch tree reduce : 1078.00 ns (0.3%)
   gen split merge   : 744.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 298.91 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.525390625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.888430817970077e-17,-8.519747407564893e-17,-5.189818301672144e-18)
    sum a = (-2.017526770647926e-17,5.839469532920028e-17,-1.056186388348479e-17)
    sum e = 2.5920015027270815
    sum de = -5.192311966668861e-19
Info: CFL hydro = 0.011126310314188752 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011126310314188752 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8954e+04 |  512 |      1 | 2.701e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1482.25361047313 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 18.73312594048482, dt = 0.011126310314188752 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.5%)
   patch tree reduce : 1094.00 ns (0.4%)
   gen split merge   : 807.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 914.00 ns  (0.3%)
   LB compute        : 278.39 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1999.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.525390625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7610912728116544e-17,-8.39665251391175e-17,-4.788040081603329e-18)
    sum a = (1.5831086441764342e-16,-6.725869861057276e-17,-8.066594267552851e-17)
    sum e = 2.592001503874041
    sum de = -6.479802046495398e-19
Info: CFL hydro = 0.011127146362040286 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011127146362040286 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9435e+04 |  512 |      1 | 2.634e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1520.44834814218 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 18.744252250799008, dt = 0.011127146362040286 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.3%)
   patch tree reduce : 1834.00 ns (0.6%)
   gen split merge   : 847.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 998.00 ns  (0.3%)
   LB compute        : 296.70 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.525390625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0631933661530154e-17,-8.570536858334976e-17,-6.16352672025422e-18)
    sum a = (6.674348573820766e-17,-1.0629192838396139e-17,1.2279630437483924e-16)
    sum e = 2.5920015050271914
    sum de = 3.5829493668856904e-19
Info: CFL hydro = 0.011128744181455652 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011128744181455652 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8951e+04 |  512 |      1 | 2.702e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1482.6746118999283 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.755379397161047, dt = 0.011128744181455652 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.5%)
   patch tree reduce : 1964.00 ns (0.7%)
   gen split merge   : 788.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 946.00 ns  (0.3%)
   LB compute        : 278.71 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1906.00 ns (64.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.525390625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0724145056300048e-17,-8.535994177119588e-17,-3.824577373551241e-18)
    sum a = (-5.177889367269373e-17,1.124100812432971e-18,-8.803114487365704e-17)
    sum e = 2.592001506156732
    sum de = 1.2273507405714812e-18
Info: CFL hydro = 0.011131096808361749 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011131096808361749 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9454e+04 |  512 |      1 | 2.632e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1522.280688105365 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.766508141342502, dt = 0.011131096808361749 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.89 us    (1.6%)
   patch tree reduce : 1730.00 ns (0.6%)
   gen split merge   : 911.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 921.00 ns  (0.3%)
   LB compute        : 284.65 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.525390625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.966590952584557e-17,-8.528529445162025e-17,-5.84956887615673e-18)
    sum a = (-4.8980351025074144e-17,6.448650207574458e-17,-1.0036698035176261e-16)
    sum e = 2.592001507197151
    sum de = -3.126610366552436e-19
Info: CFL hydro = 0.01113418603329412 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01113418603329412 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9176e+04 |  512 |      1 | 2.670e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1500.795791702905 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.777639238150865, dt = 0.01113418603329412 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.72 us    (1.6%)
   patch tree reduce : 2.02 us    (0.7%)
   gen split merge   : 1099.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 903.00 ns  (0.3%)
   LB compute        : 277.39 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1971.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.525390625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.901603874365776e-17,-8.443929149642981e-17,-7.03807129763534e-18)
    sum a = (2.923833050672009e-17,-1.644337742140109e-16,7.637445363639638e-17)
    sum e = 2.592001508088755
    sum de = -5.547007013331599e-19
Info: CFL hydro = 0.011137982900257288 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137982900257288 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9551e+04 |  512 |      1 | 2.619e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1530.5874955254872 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.78877342418416, dt = 0.011137982900257288 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.33 us    (1.7%)
   patch tree reduce : 1461.00 ns (0.5%)
   gen split merge   : 779.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 903.00 ns  (0.3%)
   LB compute        : 299.89 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.525390625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9891315157505307e-17,-8.729638106136362e-17,-5.2977641804702325e-18)
    sum a = (1.5383787993483722e-16,1.8627872681864498e-16,-7.183706754454455e-18)
    sum e = 2.592001508781682
    sum de = 5.031375706690544e-19
Info: CFL hydro = 0.01114244777739557 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114244777739557 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9514e+04 |  512 |      1 | 2.624e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.194332343759 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.79991140708442, dt = 0.01114244777739557 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.4%)
   patch tree reduce : 1243.00 ns (0.4%)
   gen split merge   : 767.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 968.00 ns  (0.3%)
   LB compute        : 293.91 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.525390625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.22068457372826e-17,-8.330348130053399e-17,-5.936657415661628e-18)
    sum a = (-1.0655538951187537e-18,7.205954583033857e-17,-1.1122743351354992e-16)
    sum e = 2.592001509240536
    sum de = -1.6364676540953083e-18
Info: CFL hydro = 0.011147531028710684 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011147531028710684 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9185e+04 |  512 |      1 | 2.669e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1503.0205372037094 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.811053854861814, dt = 0.011147531028710684 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1486.00 ns (0.5%)
   gen split merge   : 796.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 849.00 ns  (0.3%)
   LB compute        : 292.59 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.77 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.521484375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.1150073879760977e-17,-8.318346012003985e-17,-7.738438796006663e-18)
    sum a = (-4.045591986412411e-17,2.444626532455141e-17,-6.955373776929008e-18)
    sum e = 2.5920015094472695
    sum de = 3.8963515573697816e-20
Info: CFL hydro = 0.0111531560989094 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0111531560989094 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8416e+04 |  512 |      1 | 2.780e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1443.4309508759152 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.822201385890526, dt = 0.0111531560989094 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.5%)
   patch tree reduce : 1262.00 ns (0.4%)
   gen split merge   : 743.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 901.00 ns  (0.3%)
   LB compute        : 291.23 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0637788353261576e-17,-8.319224215763699e-17,-6.934882355869032e-18)
    sum a = (3.6193704283649095e-17,-2.1955093992831465e-18,2.2452742790002312e-17)
    sum e = 2.5920015094024693
    sum de = -1.4331797467542762e-18
Info: CFL hydro = 0.011150400912441443 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011150400912441443 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9482e+04 |  512 |      1 | 2.628e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.7915822062055 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.833354541989436, dt = 0.011150400912441443 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.4%)
   patch tree reduce : 1383.00 ns (0.5%)
   gen split merge   : 686.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 913.00 ns  (0.3%)
   LB compute        : 274.62 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1957.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.139304358661498e-17,-8.342789349982671e-17,-6.741677528732115e-18)
    sum a = (3.4601228132702386e-18,-2.8775809859937774e-18,-1.9788858052205427e-16)
    sum e = 2.5920015090474338
    sum de = -2.303929616531697e-19
Info: CFL hydro = 0.011147930472811766 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011147930472811766 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9055e+04 |  512 |      1 | 2.687e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1493.9705822233643 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.844504942901878, dt = 0.011147930472811766 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.5%)
   patch tree reduce : 2.12 us    (0.7%)
   gen split merge   : 785.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 914.00 ns  (0.3%)
   LB compute        : 282.38 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (64.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.1267167714389412e-17,-8.336495556371392e-17,-9.970540018611196e-18)
    sum a = (5.4799914606107336e-17,-4.092429520263785e-17,7.846457858451394e-17)
    sum e = 2.5920015085058643
    sum de = -1.3586408473958977e-18
Info: CFL hydro = 0.011145754626274838 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011145754626274838 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9299e+04 |  512 |      1 | 2.653e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1512.7579894074602 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.85565287337469, dt = 0.011145754626274838 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1541.00 ns (0.5%)
   gen split merge   : 794.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 278.37 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.22675881639961e-17,-8.402214471056601e-17,-7.628663326042506e-18)
    sum a = (2.4431628595222852e-17,-1.6112697114045727e-16,4.4542494692656475e-17)
    sum e = 2.5920015078372516
    sum de = 8.419507495707745e-19
Info: CFL hydro = 0.01114387997961309 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114387997961309 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9684e+04 |  512 |      1 | 2.601e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.6247294270715 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.866798628000964, dt = 0.01114387997961309 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.4%)
   patch tree reduce : 1078.00 ns (0.3%)
   gen split merge   : 749.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 871.00 ns  (0.3%)
   LB compute        : 298.79 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1981.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.218342697035691e-17,-8.63640214031347e-17,-7.33592873947142e-18)
    sum a = (-1.3298054064164733e-16,1.4305939245728983e-16,-7.978188422408383e-17)
    sum e = 2.592001507113151
    sum de = -1.9752808329970284e-18
Info: CFL hydro = 0.011142310131694692 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011142310131694692 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9503e+04 |  512 |      1 | 2.625e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.1307012021048 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.877942507980578, dt = 0.011142310131694692 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 1306.00 ns (0.4%)
   gen split merge   : 941.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 997.00 ns  (0.3%)
   LB compute        : 287.36 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1993.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9792517234537566e-17,-8.317028706364416e-17,-8.664943762504152e-18)
    sum a = (-5.1423952986476286e-17,-3.2786273695961654e-19,6.511588143687241e-17)
    sum e = 2.5920015064110777
    sum de = 6.403569081242511e-19
Info: CFL hydro = 0.01114104453103602 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114104453103602 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7409e+04 |  512 |      1 | 2.941e-02 | 0.1% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1363.9271214013716 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.889084818112273, dt = 0.01114104453103602 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.35 us    (1.8%)
   patch tree reduce : 1272.00 ns (0.4%)
   gen split merge   : 782.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1145.00 ns (0.4%)
   LB compute        : 282.84 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1757.00 ns (64.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9818131510862535e-17,-8.397823452258035e-17,-7.366665871061384e-18)
    sum a = (-1.687007467315177e-16,-4.718296066352767e-17,9.54051291093827e-17)
    sum e = 2.592001505808854
    sum de = 2.253107639696439e-19
Info: CFL hydro = 0.011140078918855743 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011140078918855743 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9561e+04 |  512 |      1 | 2.617e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1532.3543615368378 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.90022586264331, dt = 0.011140078918855743 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.4%)
   patch tree reduce : 1013.00 ns (0.3%)
   gen split merge   : 815.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1000.00 ns (0.3%)
   LB compute        : 304.48 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7242067149036977e-17,-8.482570115070365e-17,-6.075706344282894e-18)
    sum a = (4.825144190451214e-17,1.3344013394256394e-16,-3.302338871108423e-17)
    sum e = 2.5920015053788608
    sum de = -4.9636130709102e-19
Info: CFL hydro = 0.011138937874664055 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011138937874664055 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9433e+04 |  512 |      1 | 2.635e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1522.1983642207529 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.911365941562167, dt = 0.011138937874664055 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1059.00 ns (0.3%)
   gen split merge   : 693.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 955.00 ns  (0.3%)
   LB compute        : 287.21 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.44 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (64.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.889089470789862e-17,-8.246772405587355e-17,-7.179315735655889e-18)
    sum a = (1.280713816248502e-16,3.059661898840993e-17,5.965052670559023e-17)
    sum e = 2.592001505177775
    sum de = 1.8566962203814263e-18
Info: CFL hydro = 0.01113773197584311 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01113773197584311 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9966e+04 |  512 |      1 | 2.564e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1563.729631976508 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 18.922504879436833, dt = 0.01113773197584311 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.4%)
   patch tree reduce : 1249.00 ns (0.4%)
   gen split merge   : 744.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 877.00 ns  (0.3%)
   LB compute        : 281.89 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (60.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0629006315664445e-17,-8.238575837163365e-17,-5.8707921336831335e-18)
    sum a = (-7.901491960726759e-17,1.0538445116559103e-19,3.735183549177096e-17)
    sum e = 2.5920015052505962
    sum de = 3.066259269060567e-19
Info: CFL hydro = 0.011136827636349442 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011136827636349442 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9005e+04 |  512 |      1 | 2.694e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1488.3312219119364 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.933642611412676, dt = 0.011136827636349442 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.4%)
   patch tree reduce : 1377.00 ns (0.4%)
   gen split merge   : 832.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1016.00 ns (0.3%)
   LB compute        : 300.63 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8686712333765288e-17,-8.255993545064344e-17,-5.8268819456974705e-18)
    sum a = (-1.2037246199803065e-17,-2.2452742790002312e-17,-5.5293904220946046e-18)
    sum e = 2.592001505623463
    sum de = -4.489274620447792e-19
Info: CFL hydro = 0.011136222405304317 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011136222405304317 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9298e+04 |  512 |      1 | 2.653e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1511.1530920789348 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.944779439049025, dt = 0.011136222405304317 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1451.00 ns (0.5%)
   gen split merge   : 624.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 941.00 ns  (0.3%)
   LB compute        : 291.16 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8961882845142107e-17,-8.310003076286709e-17,-6.083024708947171e-18)
    sum a = (8.031466117164321e-17,2.816692191986991e-17,1.8779655565001607e-17)
    sum e = 2.5920015062965405
    sum de = 1.938011383317839e-18
Info: CFL hydro = 0.011135910109471644 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011135910109471644 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0003e+04 |  512 |      1 | 2.560e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1566.2550789130548 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.95591566145433, dt = 0.011135910109471644 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.3%)
   patch tree reduce : 996.00 ns  (0.3%)
   gen split merge   : 774.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1208.00 ns (0.4%)
   LB compute        : 292.46 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0400673338138998e-17,-8.242527754082074e-17,-5.75662564492041e-18)
    sum a = (-1.5222198501696481e-18,-1.202231673588794e-16,-5.3643612989151545e-18)
    sum e = 2.5920015072458003
    sum de = -4.929731753020028e-19
Info: CFL hydro = 0.011135881323171677 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011135881323171677 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9959e+04 |  512 |      1 | 2.565e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1562.7969336231602 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.9670515715638, dt = 0.011135881323171677 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.73 us    (1.5%)
   patch tree reduce : 1301.00 ns (0.4%)
   gen split merge   : 738.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1041.00 ns (0.3%)
   LB compute        : 304.28 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.45 us    (70.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.000548164626803e-17,-8.48403378800322e-17,-5.75662564492041e-18)
    sum a = (-1.5292454802473543e-16,5.869621195336849e-17,1.87847784202666e-17)
    sum e = 2.592001508423864
    sum de = 1.9024359995331586e-18
Info: CFL hydro = 0.011136123440113166 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011136123440113166 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8406e+04 |  512 |      1 | 2.782e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1441.1569397800392 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.97818745288697, dt = 0.011136123440113166 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.04 us    (1.7%)
   patch tree reduce : 1072.00 ns (0.4%)
   gen split merge   : 801.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 281.53 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1899.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7274267953559796e-17,-8.29551271425144e-17,-5.681978325344783e-18)
    sum a = (-9.835882108788495e-19,6.246077873667267e-17,-2.8784591897534904e-17)
    sum e = 2.5920015097627584
    sum de = -4.0318768289304696e-19
Info: CFL hydro = 0.011136620878350167 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011136620878350167 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9277e+04 |  512 |      1 | 2.656e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.3686883038663 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 18.989323576327084, dt = 0.010676423672915547 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1083.00 ns (0.4%)
   gen split merge   : 659.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 943.00 ns  (0.3%)
   LB compute        : 292.58 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8266638202035778e-17,-8.242235019495503e-17,-6.270374844352666e-18)
    sum a = (-1.7088674225673728e-16,-2.5151755678187727e-17,1.5925639713226803e-16)
    sum e = 2.592001507172271
    sum de = -6.822850390133389e-19
Info: CFL hydro = 0.011137328835695688 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137328835695688 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9094e+04 |  512 |      1 | 2.681e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1433.347158552664 (tsim/hr)                             [sph::Model][rank=0]
Info: iteration since start : 2068                                                    [SPH][rank=0]
Info: time since start : 1812.517780671 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14990494290780484 max=0.15011581312474181 delta=0.00021087021693697028
Number of particle pairs: 130816
Distance min=0.129508 max=1.979129 mean=0.800578
---------------- t = 19, dt = 0.011137328835695688 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 10.15 us   (1.6%)
   patch tree reduce : 1387.00 ns (0.2%)
   gen split merge   : 443.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 849.00 ns  (0.1%)
   LB compute        : 629.47 us  (96.3%)
   LB move op cnt    : 0
   LB apply          : 4.52 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (80.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.549151432134188e-17,-8.314833196965133e-17,-3.2083710688191046e-18)
    sum a = (1.637205995774771e-16,1.1578677469939459e-16,2.007281060117938e-16)
    sum e = 2.5920015124302167
    sum de = -1.4280975490707504e-18
Info: CFL hydro = 0.01113826354806152 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01113826354806152 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8692e+04 |  512 |      1 | 2.739e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1463.7847732173714 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.011137328835694, dt = 0.01113826354806152 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.4%)
   patch tree reduce : 1638.00 ns (0.6%)
   gen split merge   : 749.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 726.00 ns  (0.3%)
   LB compute        : 273.10 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.40 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.920485255199611e-17,-8.096453195383102e-17,-1.0128616695359583e-18)
    sum a = (-3.796182118653846e-17,1.9503551605768582e-16,1.2589343630076133e-16)
    sum e = 2.5920015137638837
    sum de = -7.229426204815453e-19
Info: CFL hydro = 0.011139400363845618 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011139400363845618 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9521e+04 |  512 |      1 | 2.623e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.841858739186 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 19.022275592383757, dt = 0.011139400363845618 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.4%)
   patch tree reduce : 1096.00 ns (0.4%)
   gen split merge   : 826.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 912.00 ns  (0.3%)
   LB compute        : 276.79 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.60 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1856.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7777771442462065e-17,-7.849677938903676e-17,8.782037597132586e-21)
    sum a = (5.234094407891021e-18,3.5086435709943964e-17,-1.3986273077193357e-16)
    sum e = 2.592001514856899
    sum de = 2.3251054402130544e-19
Info: CFL hydro = 0.011140706832861095 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011140706832861095 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9453e+04 |  512 |      1 | 2.632e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.629836570058 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 19.033414992747602, dt = 0.011140706832861095 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.4%)
   patch tree reduce : 1301.00 ns (0.4%)
   gen split merge   : 1114.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 1063.00 ns (0.3%)
   LB compute        : 298.61 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.68 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8076360720764572e-17,-7.904126572005899e-17,-2.8819720047923434e-18)
    sum a = (-8.723490679818369e-17,9.426492789468833e-17,7.388620965054215e-18)
    sum e = 2.592001515669505
    sum de = -9.402065714522734e-20
Info: CFL hydro = 0.011142156752053404 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011142156752053404 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9347e+04 |  512 |      1 | 2.646e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1515.5240326970245 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.044555699580464, dt = 0.011142156752053404 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.5%)
   patch tree reduce : 1679.00 ns (0.5%)
   gen split merge   : 651.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 938.00 ns  (0.3%)
   LB compute        : 291.02 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.44 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6530722103669237e-17,-7.772688742635481e-17,-2.138426154901785e-18)
    sum a = (2.700183826531699e-17,9.81012146517024e-17,5.81839264268691e-17)
    sum e = 2.592001516139306
    sum de = 1.41030985717841e-18
Info: CFL hydro = 0.011143722890355423 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011143722890355423 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9356e+04 |  512 |      1 | 2.645e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1516.4411054657587 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.055697856332518, dt = 0.011143722890355423 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 1268.00 ns (0.4%)
   gen split merge   : 660.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 950.00 ns  (0.3%)
   LB compute        : 276.85 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (63.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.752894704387664e-17,-7.620174023031945e-17,-8.935723255082406e-19)
    sum a = (2.6767650596060122e-17,-1.014413162844785e-16,-6.424353236889058e-17)
    sum e = 2.5920015162285037
    sum de = 5.505714157152952e-19
Info: CFL hydro = 0.011142210865418256 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011142210865418256 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9410e+04 |  512 |      1 | 2.638e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1520.832293548415 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 19.066841579222874, dt = 0.011142210865418256 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1202.00 ns (0.4%)
   gen split merge   : 831.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 929.00 ns  (0.3%)
   LB compute        : 281.53 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7921211389881898e-17,-7.870462094550224e-17,-2.5123945892463474e-18)
    sum a = (4.231771183471622e-17,-1.661737154129428e-16,-7.447753351541575e-17)
    sum e = 2.5920015158986587
    sum de = 5.429481191900065e-19
Info: CFL hydro = 0.011140416062137561 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011140416062137561 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9542e+04 |  512 |      1 | 2.620e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1530.9895203716133 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.077983790088293, dt = 0.011140416062137561 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.4%)
   patch tree reduce : 1437.00 ns (0.5%)
   gen split merge   : 750.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 907.00 ns  (0.3%)
   LB compute        : 287.56 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8093924795958838e-17,-8.085914750266543e-17,-3.4396313922102626e-18)
    sum a = (-1.932867928211568e-16,1.035694967288503e-17,-1.3073526636264709e-17)
    sum e = 2.5920015151969817
    sum de = -5.454892180317694e-19
Info: CFL hydro = 0.011138733648064447 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011138733648064447 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9822e+04 |  512 |      1 | 2.583e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1552.7161325066281 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.08912420615043, dt = 0.011138733648064447 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 1174.00 ns (0.4%)
   gen split merge   : 721.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 880.00 ns  (0.3%)
   LB compute        : 279.82 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4990938178305324e-17,-7.975700178422529e-17,-3.2947277718575752e-18)
    sum a = (3.351225547065795e-17,-2.4513594279462757e-17,-5.1831585898276523e-17)
    sum e = 2.5920015141776385
    sum de = -1.9312351197398048e-19
Info: CFL hydro = 0.011137185475288115 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137185475288115 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9114e+04 |  512 |      1 | 2.679e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1496.9661237829796 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.100262939798494, dt = 0.011137185475288115 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.5%)
   patch tree reduce : 1425.00 ns (0.5%)
   gen split merge   : 748.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 959.00 ns  (0.3%)
   LB compute        : 277.58 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.74 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1959.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6480957223952152e-17,-8.007461881065492e-17,-4.00753649015817e-18)
    sum a = (1.3786628089151877e-16,8.598200276765944e-17,1.6457538457026467e-17)
    sum e = 2.5920015129184977
    sum de = 6.268043809681823e-20
Info: CFL hydro = 0.011135792501541364 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011135792501541364 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9685e+04 |  512 |      1 | 2.601e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1541.4708392745956 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.111400125273782, dt = 0.011135792501541364 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.6%)
   patch tree reduce : 1355.00 ns (0.5%)
   gen split merge   : 622.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 897.00 ns  (0.3%)
   LB compute        : 274.27 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (62.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8811124533058e-17,-7.83738308626769e-17,-3.594048886626511e-18)
    sum a = (-4.284463409054417e-17,-3.786814611883571e-17,9.572420980874518e-18)
    sum e = 2.5920015115188413
    sum de = -2.0904773138236132e-18
Info: CFL hydro = 0.011134373439959619 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011134373439959619 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9393e+04 |  512 |      1 | 2.640e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.4113881441706 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.122535917775323, dt = 0.011134373439959619 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1232.00 ns (0.4%)
   gen split merge   : 712.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 947.00 ns  (0.3%)
   LB compute        : 282.01 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1853.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7259631224231243e-17,-7.960477979920833e-17,-3.2800910425290207e-18)
    sum a = (4.367600031640606e-17,6.176699776649919e-17,2.9179783589405875e-17)
    sum e = 2.592001510091498
    sum de = -1.2485265642528387e-18
Info: CFL hydro = 0.011132852189554876 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011132852189554876 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9687e+04 |  512 |      1 | 2.601e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1541.266334391815 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 19.13367029121528, dt = 0.011132852189554876 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.5%)
   patch tree reduce : 1847.00 ns (0.6%)
   gen split merge   : 753.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 291.59 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1999.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8143689675675923e-17,-7.833577536642266e-17,-2.8980724070537534e-18)
    sum a = (-4.983513601786171e-17,-7.139796566468792e-17,1.0295475409705102e-16)
    sum e = 2.5920015087569928
    sum de = 2.541098841762901e-20
Info: CFL hydro = 0.011131551674046176 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011131551674046176 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8907e+04 |  512 |      1 | 2.708e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1480.0193874078864 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.144803143404836, dt = 0.011131551674046176 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.75 us    (1.6%)
   patch tree reduce : 1273.00 ns (0.4%)
   gen split merge   : 664.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 952.00 ns  (0.3%)
   LB compute        : 276.43 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1914.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7069353742960037e-17,-7.988873234818227e-17,-1.1219053030336878e-18)
    sum a = (1.169884501772689e-16,4.241724159415039e-17,-5.383389047042275e-17)
    sum e = 2.5920015076374
    sum de = 4.2351647362715017e-20
Info: CFL hydro = 0.011130493529822046 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011130493529822046 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9333e+04 |  512 |      1 | 2.648e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1513.1995694456887 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.155934695078884, dt = 0.011130493529822046 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.5%)
   patch tree reduce : 1383.00 ns (0.5%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 276.98 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1959.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9177042766271858e-17,-7.895930003581908e-17,-2.713649617513969e-18)
    sum a = (1.8031865063605767e-16,1.4431229648781408e-16,8.442465476710125e-17)
    sum e = 2.5920015068403766
    sum de = 4.777265822514254e-19
Info: CFL hydro = 0.011129696031093646 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011129696031093646 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9391e+04 |  512 |      1 | 2.640e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1517.5807313272282 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.167065188608706, dt = 0.011129696031093646 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.3%)
   patch tree reduce : 2.25 us    (0.7%)
   gen split merge   : 952.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 919.00 ns  (0.3%)
   LB compute        : 286.40 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.1709196940111752e-17,-7.654716704247333e-17,-1.0959251084755039e-18)
    sum a = (8.770035479083172e-17,8.924892075379276e-17,2.6510044159877566e-17)
    sum e = 2.592001506454342
    sum de = -3.049318610115481e-20
Info: CFL hydro = 0.011129174334561138 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011129174334561138 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9132e+04 |  512 |      1 | 2.676e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1497.1790069329609 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.1781948846398, dt = 0.011129174334561138 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.5%)
   patch tree reduce : 1669.00 ns (0.6%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 277.19 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.210731597784843e-17,-7.637298996346354e-17,-1.082752052079805e-18)
    sum a = (3.0747377300494037e-17,-4.6913644843882274e-17,8.064837860033425e-17)
    sum e = 2.5920015065401656
    sum de = -1.6940658945086007e-20
Info: CFL hydro = 0.011128940044365774 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011128940044365774 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9348e+04 |  512 |      1 | 2.646e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1514.029071167899 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 19.18932405897436, dt = 0.011128940044365774 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.3%)
   patch tree reduce : 1645.00 ns (0.5%)
   gen split merge   : 738.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 900.00 ns  (0.3%)
   LB compute        : 287.98 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.43 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.220977308314831e-17,-7.71750827306683e-17,5.808951952269992e-20)
    sum a = (4.839122266959983e-17,-1.501377147605787e-16,6.1122981676042795e-18)
    sum e = 2.592001507126422
    sum de = 1.1909283238395463e-18
Info: CFL hydro = 0.011129000991745876 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011129000991745876 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9130e+04 |  512 |      1 | 2.676e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1496.9684010761646 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.200452999018726, dt = 0.011129000991745876 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 17.54 us   (5.6%)
   patch tree reduce : 1290.00 ns (0.4%)
   gen split merge   : 788.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1165.00 ns (0.4%)
   LB compute        : 284.11 us  (90.3%)
   LB move op cnt    : 0
   LB apply          : 3.59 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1994.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2830370406679013e-17,-7.973065567143389e-17,-8.457285165155287e-20)
    sum a = (-4.771573761108705e-18,-1.267248025266232e-16,-4.6047150467631857e-17)
    sum e = 2.5920015082062355
    sum de = 4.0149361699853836e-19
Info: CFL hydro = 0.011129361031823326 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011129361031823326 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9001e+04 |  512 |      1 | 2.695e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1486.8753535036208 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.211582000010473, dt = 0.011129361031823326 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.66 us    (1.6%)
   patch tree reduce : 1389.00 ns (0.5%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 933.00 ns  (0.3%)
   LB compute        : 278.62 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1911.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2473234211062287e-17,-8.106113436739948e-17,-7.489803074010241e-19)
    sum a = (-8.278534108230317e-18,2.312017764738439e-17,-2.85679683034723e-17)
    sum e = 2.592001509736805
    sum de = 1.1011428314305904e-20
Info: CFL hydro = 0.011130020009128216 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011130020009128216 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8950e+04 |  512 |      1 | 2.702e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1482.9213018938524 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.222711361042297, dt = 0.011130020009128216 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.5%)
   patch tree reduce : 1400.00 ns (0.5%)
   gen split merge   : 727.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1281.00 ns (0.4%)
   LB compute        : 289.22 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1976.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2361995068165273e-17,-8.002192658507212e-17,-1.4934495290832087e-18)
    sum a = (-1.3400218434878042e-16,1.9004329360194915e-17,2.675594121259728e-17)
    sum e = 2.5920015116405564
    sum de = -3.3881317890172014e-19
Info: CFL hydro = 0.011130973573191786 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011130973573191786 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9590e+04 |  512 |      1 | 2.614e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.0354438573677 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.233841381051427, dt = 0.011130973573191786 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.4%)
   patch tree reduce : 1209.00 ns (0.4%)
   gen split merge   : 642.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 871.00 ns  (0.3%)
   LB compute        : 272.95 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1858.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0017191029730875e-17,-7.950525003977416e-17,-6.3322150257658085e-19)
    sum a = (1.202026759378194e-16,2.0090667410960217e-16,-6.979670747614408e-17)
    sum e = 2.592001513809628
    sum de = 5.98005260761536e-19
Info: CFL hydro = 0.011132212884683659 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011132212884683659 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9288e+04 |  512 |      1 | 2.655e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.5390986830596 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.24497235462462, dt = 0.011132212884683659 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.6%)
   patch tree reduce : 1390.00 ns (0.5%)
   gen split merge   : 643.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 887.00 ns  (0.3%)
   LB compute        : 275.06 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3038211963144485e-17,-7.612562923781096e-17,-1.805989440026995e-18)
    sum a = (-1.2274946684098786e-16,-3.577216647898673e-18,-5.046158803312384e-17)
    sum e = 2.5920015161135734
    sum de = -9.931461306556671e-19
Info: CFL hydro = 0.011133724714517018 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011133724714517018 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0060e+04 |  512 |      1 | 2.552e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1570.1982110422125 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.2561045675093, dt = 0.011133724714517018 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.5%)
   patch tree reduce : 1183.00 ns (0.4%)
   gen split merge   : 685.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 879.00 ns  (0.3%)
   LB compute        : 277.15 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.38 us    (70.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0304070924570538e-17,-7.771517804289196e-17,-2.402253201048976e-18)
    sum a = (1.9397764644546455e-16,6.1620630473213645e-18,1.168303735005205e-17)
    sum e = 2.5920015184077494
    sum de = 4.961495488542064e-19
Info: CFL hydro = 0.011135491732225054 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011135491732225054 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9828e+04 |  512 |      1 | 2.582e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1552.2517866925214 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.26723829222382, dt = 0.011135491732225054 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.94 us    (1.5%)
   patch tree reduce : 1306.00 ns (0.5%)
   gen split merge   : 627.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 834.00 ns  (0.3%)
   LB compute        : 256.82 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1919.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.4162312775577455e-17,-7.743415283978372e-17,-1.7392093624654657e-18)
    sum a = (1.764721181685136e-16,3.2557940718436205e-17,-6.6011649271779935e-18)
    sum e = 2.592001520543339
    sum de = -2.726387298974779e-19
Info: CFL hydro = 0.011137492815957642 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137492815957642 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9841e+04 |  512 |      1 | 2.581e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1553.484928517706 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 19.278373783956045, dt = 0.011137492815957642 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.4%)
   patch tree reduce : 1305.00 ns (0.5%)
   gen split merge   : 685.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 901.00 ns  (0.3%)
   LB compute        : 265.12 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1867.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.6179254077052237e-17,-7.704042482084561e-17,-2.0440192507326094e-18)
    sum a = (1.56847191484788e-16,4.4423937185095185e-17,5.939218843294125e-17)
    sum e = 2.5920015223780015
    sum de = 6.96684599116662e-19
Info: CFL hydro = 0.011139703504194675 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011139703504194675 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0359e+04 |  512 |      1 | 2.515e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1594.3174955789925 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.289511276772004, dt = 0.011139703504194675 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.4%)
   patch tree reduce : 1561.00 ns (0.5%)
   gen split merge   : 640.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 804.00 ns  (0.3%)
   LB compute        : 275.41 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.67 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.7651709047504802e-17,-7.645495564770344e-17,-9.934680031756237e-19)
    sum a = (-6.252810769158401e-17,-1.7351842619001133e-17,7.095886378483129e-18)
    sum e = 2.5920015237868714
    sum de = -1.7279472123987727e-19
Info: CFL hydro = 0.011142095899417172 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011142095899417172 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0095e+04 |  512 |      1 | 2.548e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1573.9908057831817 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.3006509802762, dt = 0.011142095899417172 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.2%)
   patch tree reduce : 1349.00 ns (0.4%)
   gen split merge   : 632.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 845.00 ns  (0.3%)
   LB compute        : 316.00 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.61 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.46 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5822117881435514e-17,-7.668621597109459e-17,-1.3460302208771758e-18)
    sum a = (-7.87221850206965e-17,-6.613057269757444e-17,1.0777755641080966e-16)
    sum e = 2.5920015246727117
    sum de = -8.309393212564686e-19
Info: CFL hydro = 0.011144639240251332 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011144639240251332 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9592e+04 |  512 |      1 | 2.613e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1534.892206308268 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 19.311793076175615, dt = 0.011144639240251332 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 1146.00 ns (0.4%)
   gen split merge   : 709.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 906.00 ns  (0.3%)
   LB compute        : 275.05 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.475656398631676e-17,-7.780153474593043e-17,4.109261758991622e-19)
    sum a = (-1.660976044204343e-16,-4.751727270934768e-17,6.153720111604089e-17)
    sum e = 2.592001524972425
    sum de = -3.5829493668856904e-19
Info: CFL hydro = 0.011147300290474237 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011147300290474237 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9653e+04 |  512 |      1 | 2.605e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1540.0064679488416 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.322937715415865, dt = 0.011147300290474237 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.4%)
   patch tree reduce : 1717.00 ns (0.6%)
   gen split merge   : 1101.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 851.00 ns  (0.3%)
   LB compute        : 272.85 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2341503647105298e-17,-7.821429051299566e-17,1.0256688076984432e-18)
    sum a = (1.0633291122608134e-16,-1.6245744983642286e-16,4.1129209413237613e-17)
    sum e = 2.5920015246633357
    sum de = 4.743384504624082e-20
Info: CFL hydro = 0.011150043975036376 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011150043975036376 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9263e+04 |  512 |      1 | 2.658e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.8156535035812 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.33408501570634, dt = 0.011150043975036376 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.87 us    (1.7%)
   patch tree reduce : 1471.00 ns (0.5%)
   gen split merge   : 688.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 907.00 ns  (0.3%)
   LB compute        : 274.48 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5119554873664905e-17,-8.073766264923843e-17,1.3289235434744278e-18)
    sum a = (2.142817173700351e-18,-6.185335446953765e-17,-1.3521996022891613e-16)
    sum e = 2.592001523765792
    sum de = 1.2536087619363645e-19
Info: CFL hydro = 0.011152834198548536 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011152834198548536 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9455e+04 |  512 |      1 | 2.632e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1525.2164442356225 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.345235059681375, dt = 0.011152834198548536 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.5%)
   patch tree reduce : 1374.00 ns (0.5%)
   gen split merge   : 705.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 848.00 ns  (0.3%)
   LB compute        : 277.05 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1894.00 ns (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.458385058023982e-17,-8.1227993081745e-17,-1.1460101666466508e-18)
    sum a = (8.933088643803267e-17,-6.93561419233546e-17,1.1568870861289326e-17)
    sum e = 2.59200152234454
    sum de = -1.179069862577986e-18
Info: CFL hydro = 0.011155633747730171 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011155633747730171 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9481e+04 |  512 |      1 | 2.628e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.6440775013002 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.356387893879923, dt = 0.011155633747730171 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.86 us    (1.6%)
   patch tree reduce : 1221.00 ns (0.4%)
   gen split merge   : 792.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 287.74 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.34 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5945066407795368e-17,-8.201691279255407e-17,-2.380069408160386e-19)
    sum a = (2.0468002293050346e-17,8.90571795995887e-17,-6.361708035362845e-17)
    sum e = 2.592001520503564
    sum de = -3.8455295805345235e-19
Info: CFL hydro = 0.01115840551066037 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115840551066037 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9691e+04 |  512 |      1 | 2.600e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1544.5051457823656 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.367543527627653, dt = 0.01115840551066037 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 1380.00 ns (0.5%)
   gen split merge   : 1159.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 881.00 ns  (0.3%)
   LB compute        : 276.02 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1940.00 ns (64.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5945066407795368e-17,-8.042443664160736e-17,-1.2480556139341653e-18)
    sum a = (-7.920226974267308e-17,-3.407430587687443e-17,3.3705460297794863e-17)
    sum e = 2.5920015183799197
    sum de = 3.6083603553033194e-19
Info: CFL hydro = 0.0111606788473498 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0111606788473498 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9714e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1546.7150091251485 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.378701933138313, dt = 0.0111606788473498 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.5%)
   patch tree reduce : 1296.00 ns (0.4%)
   gen split merge   : 692.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 853.00 ns  (0.3%)
   LB compute        : 272.67 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.4294043339534444e-17,-8.081670098761263e-17,-4.678264611639171e-19)
    sum a = (-4.554950167046101e-17,1.0603724929364455e-16,-1.926193579637747e-17)
    sum e = 2.592001516132024
    sum de = -1.1214716221646936e-18
Info: CFL hydro = 0.011160318035408423 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011160318035408423 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9816e+04 |  512 |      1 | 2.584e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1555.0289816479844 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.389862611985663, dt = 0.011160318035408423 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.4%)
   patch tree reduce : 1544.00 ns (0.5%)
   gen split merge   : 735.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 880.00 ns  (0.3%)
   LB compute        : 286.30 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.4084738110136115e-17,-7.939693824274285e-17,-8.915597752255644e-19)
    sum a = (1.0573573266947634e-17,-6.422596829369631e-17,-1.282060395346729e-16)
    sum e = 2.592001513920332
    sum de = 8.131516293641283e-20
Info: CFL hydro = 0.011160035012798901 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011160035012798901 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9011e+04 |  512 |      1 | 2.693e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1491.7778717630501 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.40102293002107, dt = 0.011160035012798901 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.4%)
   patch tree reduce : 1327.00 ns (0.5%)
   gen split merge   : 796.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 849.00 ns  (0.3%)
   LB compute        : 270.05 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.433648985458725e-17,-8.088110259665826e-17,-3.0312666439435977e-18)
    sum a = (5.509264919267842e-18,5.112024085290878e-17,8.277363169884033e-17)
    sum e = 2.592001511945069
    sum de = 5.116079001415974e-19
Info: CFL hydro = 0.011159842204663447 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011159842204663447 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9260e+04 |  512 |      1 | 2.658e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1511.329748052162 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 19.41218296503387, dt = 0.011159842204663447 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 1145.00 ns (0.4%)
   gen split merge   : 718.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 859.00 ns  (0.3%)
   LB compute        : 271.30 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1940.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.465703422688259e-17,-7.961502550973831e-17,-8.990610990064485e-19)
    sum a = (-6.922587503233046e-17,7.565432655343152e-17,-3.9343528435153984e-17)
    sum e = 2.592001510370309
    sum de = -2.947674656444965e-19
Info: CFL hydro = 0.011159749768564793 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011159749768564793 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9699e+04 |  512 |      1 | 2.599e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1545.725549685199 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 19.423342807238534, dt = 0.011159749768564793 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.99 us    (1.4%)
   patch tree reduce : 1312.00 ns (0.5%)
   gen split merge   : 1017.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 867.00 ns  (0.3%)
   LB compute        : 271.14 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1914.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3374856737701233e-17,-7.864900137405373e-17,-1.978153968754115e-18)
    sum a = (1.973031113489121e-18,-9.71293358242864e-17,9.075943122049956e-17)
    sum e = 2.5920015093359114
    sum de = 7.250602028496811e-19
Info: CFL hydro = 0.011159765384537721 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011159765384537721 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9791e+04 |  512 |      1 | 2.587e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1552.9139848510667 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.4345025570071, dt = 0.011159765384537721 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.4%)
   patch tree reduce : 1150.00 ns (0.4%)
   gen split merge   : 790.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 919.00 ns  (0.3%)
   LB compute        : 274.94 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.34 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.38915332829992e-17,-8.065423329206567e-17,-5.04235325368696e-19)
    sum a = (-1.7744985168766102e-16,7.22264045446841e-17,-1.147285391689401e-16)
    sum e = 2.5920015089463866
    sum de = -5.759824041329242e-19
Info: CFL hydro = 0.011159893792355024 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011159893792355024 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9767e+04 |  512 |      1 | 2.590e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1551.042612577106 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 19.445662322391637, dt = 0.011159893792355024 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.5%)
   patch tree reduce : 1598.00 ns (0.5%)
   gen split merge   : 748.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 856.00 ns  (0.3%)
   LB compute        : 289.30 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.112080042110387e-17,-7.894027228769196e-17,-2.7707328618953307e-18)
    sum a = (1.444498817435025e-16,1.0421351281930669e-18,3.499934717043907e-17)
    sum e = 2.592001509263309
    sum de = 1.3179832659276913e-18
Info: CFL hydro = 0.011160137096885124 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011160137096885124 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9426e+04 |  512 |      1 | 2.636e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1524.2916431584008 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.456822216183994, dt = 0.011160137096885124 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.73 us    (1.6%)
   patch tree reduce : 1289.00 ns (0.4%)
   gen split merge   : 725.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1203.00 ns (0.4%)
   LB compute        : 272.88 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1994.00 ns (63.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.433356250872154e-17,-7.950525003977416e-17,-1.348042771159852e-18)
    sum a = (-3.8111481743922924e-17,-7.171997370991612e-19,1.2107502500580125e-16)
    sum e = 2.592001510300227
    sum de = -3.5236570605778894e-19
Info: CFL hydro = 0.01116049442807423 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01116049442807423 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8763e+04 |  512 |      1 | 2.729e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1472.3061015185551 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.467982353280878, dt = 0.01116049442807423 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.6%)
   patch tree reduce : 1669.00 ns (0.6%)
   gen split merge   : 652.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 915.00 ns  (0.3%)
   LB compute        : 258.79 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.299722912102453e-17,-7.905151143058897e-17,5.1301736296582855e-19)
    sum a = (-2.5182492809777688e-17,1.558811673491034e-17,-2.7903460791955934e-17)
    sum e = 2.592001512019838
    sum de = -7.284483346386983e-20
Info: CFL hydro = 0.011160961856714875 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011160961856714875 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9933e+04 |  512 |      1 | 2.569e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1564.1777104143443 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.479142847708953, dt = 0.011160961856714875 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.5%)
   patch tree reduce : 1400.00 ns (0.5%)
   gen split merge   : 678.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 795.00 ns  (0.3%)
   LB compute        : 270.41 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2900626707456074e-17,-7.880707805080211e-17,-8.196568423990413e-19)
    sum a = (1.355097674696215e-16,1.0429547850354659e-16,-1.2269091992367365e-16)
    sum e = 2.5920015143364017
    sum de = -9.571472303973594e-19
Info: CFL hydro = 0.011161532584940626 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011161532584940626 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0389e+04 |  512 |      1 | 2.511e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1600.0439115652723 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.490303809565667, dt = 0.009696190434333118 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.5%)
   patch tree reduce : 1213.00 ns (0.4%)
   gen split merge   : 775.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 786.00 ns  (0.3%)
   LB compute        : 277.03 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.505808061048498e-17,-7.744147120444799e-17,-2.5467909031684497e-18)
    sum a = (9.306617976267973e-17,8.051079334464584e-17,-5.3500173041731713e-17)
    sum e = 2.5920015063539075
    sum de = -1.6195269951502222e-18
Info: CFL hydro = 0.011162114622938372 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011162114622938372 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9667e+04 |  512 |      1 | 2.603e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1340.855789177955 (tsim/hr)                             [sph::Model][rank=0]
Info: iteration since start : 2113                                                    [SPH][rank=0]
Info: time since start : 1814.3277675040001 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14992041954136734 max=0.15008093239447878 delta=0.00016051285311144414
Number of particle pairs: 130816
Distance min=0.128878 max=1.939100 mean=0.800580
---------------- t = 19.5, dt = 0.011162114622938372 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 8.95 us    (1.3%)
   patch tree reduce : 1297.00 ns (0.2%)
   gen split merge   : 685.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 842.00 ns  (0.1%)
   LB compute        : 670.91 us  (96.6%)
   LB move op cnt    : 0
   LB apply          : 4.38 us    (0.6%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (76.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5803090133308393e-17,-7.655448540713761e-17,-2.8102520310824273e-18)
    sum a = (-6.00457183974612e-17,8.339422902237104e-17,-3.606490106555782e-18)
    sum e = 2.5920015193709602
    sum de = 1.773686991550505e-18
Info: CFL hydro = 0.011162840892250765 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011162840892250765 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6953e+04 |  512 |      1 | 3.020e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1330.5573379278403 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.511162114622937, dt = 0.011162840892250765 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.94 us    (1.3%)
   patch tree reduce : 1277.00 ns (0.4%)
   gen split merge   : 649.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 962.00 ns  (0.3%)
   LB compute        : 296.29 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.4434555941088565e-17,-7.591193298961407e-17,-2.6155835310126553e-18)
    sum a = (-5.138077463495705e-17,-2.1097381654178182e-17,5.917922402121078e-17)
    sum e = 2.5920015227585127
    sum de = 1.8295911660692887e-19
Info: CFL hydro = 0.011163645758161018 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011163645758161018 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9386e+04 |  512 |      1 | 2.641e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1521.5634072961614 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.522324955515188, dt = 0.011163645758161018 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.4%)
   patch tree reduce : 1458.00 ns (0.5%)
   gen split merge   : 699.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 852.00 ns  (0.3%)
   LB compute        : 279.29 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3925197760454874e-17,-7.656180377180189e-17,-1.348042771159852e-18)
    sum a = (7.157360641663057e-17,-8.881274621980184e-17,4.3500359564463406e-17)
    sum e = 2.5920015258911944
    sum de = -9.029371217730842e-19
Info: CFL hydro = 0.0111645029598915 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0111645029598915 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9770e+04 |  512 |      1 | 2.590e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1551.8648956684908 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.533488601273348, dt = 0.0111645029598915 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.3%)
   patch tree reduce : 1154.00 ns (0.4%)
   gen split merge   : 761.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1598.00 ns (0.5%)
   LB compute        : 294.33 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.539033436624316e-17,-7.816891665207715e-17,-1.1431285605600916e-18)
    sum a = (5.598256233585452e-17,-5.8678647878174226e-18,-8.749251323436624e-17)
    sum e = 2.592001528765099
    sum de = -9.910285482875314e-19
Info: CFL hydro = 0.011165394225116755 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011165394225116755 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9760e+04 |  512 |      1 | 2.591e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1551.1772998714816 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.54465310423324, dt = 0.011165394225116755 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.76 us    (1.6%)
   patch tree reduce : 1086.00 ns (0.4%)
   gen split merge   : 1111.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 933.00 ns  (0.3%)
   LB compute        : 283.42 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1874.00 ns (64.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.564940447535857e-17,-7.753075525335218e-17,-2.8483075273366688e-18)
    sum a = (-3.345370855334373e-17,-8.22393910783481e-17,-8.879225479874186e-17)
    sum e = 2.59200153119557
    sum de = -2.185345003916095e-19
Info: CFL hydro = 0.011166299695203656 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011166299695203656 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9419e+04 |  512 |      1 | 2.637e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1524.5473346024796 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.555818498458358, dt = 0.011166299695203656 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.1%)
   patch tree reduce : 1276.00 ns (0.3%)
   gen split merge   : 795.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1015.00 ns (0.3%)
   LB compute        : 355.26 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 4.00 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.46863076855397e-17,-7.879683234027213e-17,-3.722120268251361e-18)
    sum a = (4.605300515936328e-17,3.461952404436308e-17,-5.541465723790662e-17)
    sum e = 2.5920015330262194
    sum de = -6.37392292808861e-19
Info: CFL hydro = 0.011166916890027308 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011166916890027308 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9059e+04 |  512 |      1 | 2.686e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1496.4107446988803 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.566984798153563, dt = 0.011166916890027308 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1234.00 ns (0.4%)
   gen split merge   : 620.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 855.00 ns  (0.3%)
   LB compute        : 286.00 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1948.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5991903941646744e-17,-7.766248581730916e-17,-4.4510293888133656e-18)
    sum a = (-7.69423587343443e-17,-2.326178800363815e-17,4.751667809221871e-17)
    sum e = 2.592001534137295
    sum de = 2.549569171235444e-19
Info: CFL hydro = 0.011167028940665139 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011167028940665139 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9565e+04 |  512 |      1 | 2.617e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.1587935362602 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.57815171504359, dt = 0.011167028940665139 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.62 us    (1.3%)
   patch tree reduce : 1237.00 ns (0.4%)
   gen split merge   : 793.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1218.00 ns (0.4%)
   LB compute        : 272.13 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.4203295617697406e-17,-7.862119158832948e-17,-3.0678584672649833e-18)
    sum a = (2.7727820040013285e-17,2.045995209191964e-17,2.8500639348560954e-17)
    sum e = 2.5920015344585448
    sum de = 7.057902032996458e-19
Info: CFL hydro = 0.011167037483039403 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011167037483039403 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9672e+04 |  512 |      1 | 2.603e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1544.5836201373702 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.589318743984254, dt = 0.011167037483039403 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.73 us    (1.2%)
   patch tree reduce : 1268.00 ns (0.4%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 817.00 ns  (0.3%)
   LB compute        : 297.30 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5148828332322015e-17,-7.83738308626769e-17,-2.993211147689356e-18)
    sum a = (-4.511625448233581e-17,-5.66024278229188e-17,-1.144592233492947e-17)
    sum e = 2.592001533979357
    sum de = -1.6855955650360577e-19
Info: CFL hydro = 0.011166933271116081 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011166933271116081 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9271e+04 |  512 |      1 | 2.657e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1513.0931255665198 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.600485781467295, dt = 0.011166933271116081 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.64 us    (1.2%)
   patch tree reduce : 1235.00 ns (0.4%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 736.00 ns  (0.2%)
   LB compute        : 294.20 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1892.00 ns (64.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.4124257279323214e-17,-7.870462094550224e-17,-3.408894260620299e-18)
    sum a = (-1.2233963841978835e-16,-3.191977931971124e-17,-6.412058384253072e-17)
    sum e = 2.592001532740433
    sum de = 2.718975760686304e-19
Info: CFL hydro = 0.011166708749008963 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011166708749008963 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9805e+04 |  512 |      1 | 2.585e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1555.0569176319514 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.611652714738412, dt = 0.011166708749008963 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.4%)
   patch tree reduce : 1406.00 ns (0.5%)
   gen split merge   : 747.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 902.00 ns  (0.3%)
   LB compute        : 290.32 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.71 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1902.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.234443099297101e-17,-7.938376518634716e-17,-4.3866277797677265e-18)
    sum a = (1.4422447611184273e-16,-5.4922863132467194e-17,-3.063174713879846e-17)
    sum e = 2.5920015308370727
    sum de = 6.445920728605226e-19
Info: CFL hydro = 0.011166358089028664 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011166358089028664 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9633e+04 |  512 |      1 | 2.608e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1541.4692192546213 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.62281942348742, dt = 0.011166358089028664 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.94 us    (1.4%)
   patch tree reduce : 1534.00 ns (0.5%)
   gen split merge   : 754.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 872.00 ns  (0.3%)
   LB compute        : 274.86 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.539765273090744e-17,-8.003070862266926e-17,-4.41443756549198e-18)
    sum a = (3.5163278538918875e-17,1.0345240289422186e-16,3.0046277965656286e-17)
    sum e = 2.5920015284100573
    sum de = -1.1519648082658485e-19
Info: CFL hydro = 0.011165877290987168 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011165877290987168 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9797e+04 |  512 |      1 | 2.586e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1554.2999493022523 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.63398578157645, dt = 0.011165877290987168 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.5%)
   patch tree reduce : 1234.00 ns (0.4%)
   gen split merge   : 651.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 940.00 ns  (0.3%)
   LB compute        : 288.73 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.513419160299346e-17,-7.782788085872183e-17,-3.948989572843953e-18)
    sum a = (1.1593460566561298e-16,1.1932447217810616e-16,6.353218732352284e-17)
    sum e = 2.5920015256386337
    sum de = 1.1401063470042883e-18
Info: CFL hydro = 0.011165264427695954 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011165264427695954 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9829e+04 |  512 |      1 | 2.582e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1556.7845049005118 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.645151658867437, dt = 0.011165264427695954 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1446.00 ns (0.5%)
   gen split merge   : 716.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 915.00 ns  (0.3%)
   LB compute        : 293.52 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.60 us    (72.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.731506427294805e-17,-7.640079974918779e-17,-3.006384204085055e-18)
    sum a = (-6.509246266994672e-17,-1.9560525074679978e-17,9.382143499603312e-18)
    sum e = 2.592001522724987
    sum de = 7.420008617947671e-19
Info: CFL hydro = 0.011164520224448452 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011164520224448452 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9576e+04 |  512 |      1 | 2.615e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.834968797584 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 19.656316923295133, dt = 0.011164520224448452 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1308.00 ns (0.4%)
   gen split merge   : 757.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 869.00 ns  (0.3%)
   LB compute        : 274.97 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1967.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5324469084264667e-17,-7.783666289631897e-17,-3.1468968056391765e-18)
    sum a = (-2.693158196453993e-18,-7.030606565677777e-17,1.4493289381134477e-17)
    sum e = 2.5920015198832953
    sum de = -1.7414997395548415e-18
Info: CFL hydro = 0.011163647906971717 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011163647906971717 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9391e+04 |  512 |      1 | 2.640e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1522.2374924342912 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.66748144351958, dt = 0.011163647906971717 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.5%)
   patch tree reduce : 1169.00 ns (0.4%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1392.00 ns (0.5%)
   LB compute        : 275.46 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1996.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5705024046807078e-17,-7.856118099808241e-17,-2.965401361965103e-18)
    sum a = (-2.2710349226184868e-17,-7.283236513888625e-18,9.865155567445605e-17)
    sum e = 2.592001517322609
    sum de = -1.3484764520288461e-18
Info: CFL hydro = 0.011162652235426071 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011162652235426071 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9768e+04 |  512 |      1 | 2.590e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1551.7127631997826 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.678645091426553, dt = 0.011162652235426071 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 1108.00 ns (0.4%)
   gen split merge   : 734.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1364.00 ns (0.5%)
   LB compute        : 283.28 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1894.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5277631550413294e-17,-7.840456799426687e-17,-1.4724549704525635e-18)
    sum a = (-1.0677201310593798e-16,7.453022574099854e-17,9.165519905540709e-17)
    sum e = 2.5920015152317326
    sum de = -1.4823076576950256e-18
Info: CFL hydro = 0.011161541268368276 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011161541268368276 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9486e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.4356319630085 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.68980774366198, dt = 0.011161541268368276 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.76 us    (1.6%)
   patch tree reduce : 1072.00 ns (0.4%)
   gen split merge   : 735.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1111.00 ns (0.4%)
   LB compute        : 281.88 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1944.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3729065587452247e-17,-7.707994399003271e-17,-2.634611279139776e-19)
    sum a = (2.1106163691775313e-17,-1.1431285605600915e-16,-6.17911483698913e-17)
    sum e = 2.592001513766821
    sum de = 1.6940658945086007e-21
Info: CFL hydro = 0.011160324906351346 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011160324906351346 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9273e+04 |  512 |      1 | 2.657e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1512.5359882972996 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.70096928493035, dt = 0.011160324906351346 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.76 us    (1.6%)
   patch tree reduce : 1316.00 ns (0.4%)
   gen split merge   : 865.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 924.00 ns  (0.3%)
   LB compute        : 278.36 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.4738999911122494e-17,-7.949354065631131e-17,-2.014013955609073e-18)
    sum a = (3.982946784886199e-17,8.164953088640736e-17,-4.585120125374584e-17)
    sum e = 2.5920015130400715
    sum de = 1.7448878713438587e-19
Info: CFL hydro = 0.011159015676755663 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011159015676755663 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9234e+04 |  512 |      1 | 2.662e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.3494656088772 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.7121296098367, dt = 0.011159015676755663 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1444.00 ns (0.5%)
   gen split merge   : 699.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 873.00 ns  (0.3%)
   LB compute        : 280.08 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.32 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1907.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.530105031733898e-17,-7.759954788119639e-17,-2.499953369317076e-18)
    sum a = (-1.4196895612231252e-16,2.0520694518633144e-17,1.6602442077379155e-17)
    sum e = 2.592001513111782
    sum de = 1.2180333781516839e-18
Info: CFL hydro = 0.01115762791287224 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115762791287224 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9606e+04 |  512 |      1 | 2.611e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1538.2971573386621 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.723288625513458, dt = 0.01115762791287224 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.5%)
   patch tree reduce : 1721.00 ns (0.6%)
   gen split merge   : 808.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 950.00 ns  (0.3%)
   LB compute        : 278.41 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 2.78 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2569836624630744e-17,-7.750587281349364e-17,-1.946685000697723e-18)
    sum a = (3.21089590462828e-17,3.677917345679127e-17,5.058453655948369e-18)
    sum e = 2.592001513985946
    sum de = 1.57378721599849e-18
Info: CFL hydro = 0.01115617799199294 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115617799199294 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9524e+04 |  512 |      1 | 2.622e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.6944076974726 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.73444625342633, dt = 0.01115617799199294 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.78 us    (1.6%)
   patch tree reduce : 1446.00 ns (0.5%)
   gen split merge   : 747.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1064.00 ns (0.4%)
   LB compute        : 276.69 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1915.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3919343068723452e-17,-7.73492598096781e-17,-1.776898940486493e-18)
    sum a = (7.473953097039687e-17,1.1931861748637473e-16,-1.1104886541574154e-17)
    sum e = 2.5920015156104723
    sum de = 4.387630666777276e-19
Info: CFL hydro = 0.011154683894211486 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011154683894211486 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9338e+04 |  512 |      1 | 2.648e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1516.9264121424765 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.745602431418323, dt = 0.011154683894211486 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.6%)
   patch tree reduce : 1466.00 ns (0.5%)
   gen split merge   : 689.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 929.00 ns  (0.3%)
   LB compute        : 280.26 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1955.00 ns (64.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5037589189425004e-17,-7.532792748940476e-17,-2.245274279000231e-18)
    sum a = (4.0262715036987196e-17,-3.704848927643667e-17,3.212176618444529e-17)
    sum e = 2.592001517880318
    sum de = 3.7100043089738355e-19
Info: CFL hydro = 0.01115316527587922 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115316527587922 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9313e+04 |  512 |      1 | 2.651e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1514.7745255505718 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.756757115312535, dt = 0.01115316527587922 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1672.00 ns (0.6%)
   gen split merge   : 766.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 907.00 ns  (0.3%)
   LB compute        : 282.80 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1985.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5224939324830497e-17,-7.653984867780906e-17,-1.4548908952582985e-18)
    sum a = (-1.1544281156017355e-16,-2.6196818152246504e-16,-4.663554698663974e-17)
    sum e = 2.59200152064565
    sum de = 1.3383120566617945e-19
Info: CFL hydro = 0.011151643234464414 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011151643234464414 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9818e+04 |  512 |      1 | 2.583e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1554.1699599473618 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.767910280588413, dt = 0.011151643234464414 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.4%)
   patch tree reduce : 1218.00 ns (0.4%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 997.00 ns  (0.3%)
   LB compute        : 278.13 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1880.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3187506602295737e-17,-8.055763087849721e-17,-2.24234693313452e-18)
    sum a = (1.4359802409658063e-16,1.875491949243635e-16,1.500850225349959e-17)
    sum e = 2.5920015237225402
    sum de = -4.607859233063394e-19
Info: CFL hydro = 0.011150140186911817 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011150140186911817 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9179e+04 |  512 |      1 | 2.670e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1503.855661771186 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 19.779061923822876, dt = 0.011150140186911817 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.16 us    (1.7%)
   patch tree reduce : 2.12 us    (0.7%)
   gen split merge   : 780.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 906.00 ns  (0.3%)
   LB compute        : 290.58 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1959.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.6196818152246503e-17,-7.582630812304203e-17,-1.8090997450093127e-18)
    sum a = (9.701809668138938e-17,-5.1105604123580227e-17,4.6849243234836635e-17)
    sum e = 2.5920015269064125
    sum de = 1.2451384324638215e-18
Info: CFL hydro = 0.011148679239347871 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011148679239347871 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9635e+04 |  512 |      1 | 2.608e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1539.3718419020774 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.79021206400979, dt = 0.011148679239347871 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1603.00 ns (0.5%)
   gen split merge   : 723.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 909.00 ns  (0.3%)
   LB compute        : 291.57 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (70.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.706623987436263e-17,-7.789447797716675e-17,-1.1753293650829111e-18)
    sum a = (1.4874429812850032e-16,2.8682134792235025e-17,7.086811606299426e-17)
    sum e = 2.5920015299865216
    sum de = 5.929230630780102e-19
Info: CFL hydro = 0.011147284306804986 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011147284306804986 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9933e+04 |  512 |      1 | 2.569e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1562.5181862477723 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.801360743249138, dt = 0.011147284306804986 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.3%)
   patch tree reduce : 1277.00 ns (0.4%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 917.00 ns  (0.3%)
   LB compute        : 294.65 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.8816792702057726e-17,-7.7436348349183e-17,-2.1515992112974835e-19)
    sum a = (1.6147239795261113e-17,-2.7423376069979356e-17,6.458310448931303e-17)
    sum e = 2.5920015327619996
    sum de = -4.2266944067989587e-19
Info: CFL hydro = 0.011145979704936054 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011145979704936054 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9275e+04 |  512 |      1 | 2.656e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.7437642073007 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.812508027555943, dt = 0.011145979704936054 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.4%)
   patch tree reduce : 1311.00 ns (0.4%)
   gen split merge   : 786.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 889.00 ns  (0.3%)
   LB compute        : 288.98 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.832207125075259e-17,-7.810597871596436e-17,5.883965190078832e-19)
    sum a = (-8.910840815223864e-18,-1.4257930773531323e-16,1.8828688608252263e-17)
    sum e = 2.592001535055411
    sum de = -9.952637130238029e-19
Info: CFL hydro = 0.011144790014792124 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011144790014792124 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9602e+04 |  512 |      1 | 2.612e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.2029931989039 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.823654007260878, dt = 0.011144790014792124 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1125.00 ns (0.4%)
   gen split merge   : 776.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 916.00 ns  (0.3%)
   LB compute        : 274.27 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1885.00 ns (63.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.812008438601854e-17,-7.997069803242219e-17,3.263990640267611e-19)
    sum a = (7.366373136474813e-17,1.3137928245310349e-17,-3.201930907914541e-17)
    sum e = 2.5920015367251885
    sum de = 9.143720665610172e-19
Info: CFL hydro = 0.011143739942326364 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011143739942326364 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9449e+04 |  512 |      1 | 2.633e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1524.053469570004 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 19.83479879727567, dt = 0.011143739942326364 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.5%)
   patch tree reduce : 2.10 us    (0.7%)
   gen split merge   : 1123.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 898.00 ns  (0.3%)
   LB compute        : 282.51 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.63 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1957.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.925589458191436e-17,-7.902004246253258e-17,-1.6393136847980827e-19)
    sum a = (-5.583034035083756e-17,5.90738395700452e-17,-2.6990128881854147e-17)
    sum e = 2.5920015376755776
    sum de = 1.3162892000331827e-18
Info: CFL hydro = 0.01114285375763707 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114285375763707 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9246e+04 |  512 |      1 | 2.660e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1508.0352986912458 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.845942537217997, dt = 0.01114285375763707 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1353.00 ns (0.5%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 934.00 ns  (0.3%)
   LB compute        : 279.37 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1807.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.792687955888162e-17,-7.80357224151873e-17,-7.025630077706068e-19)
    sum a = (-4.8418300618857655e-17,1.6136115880971414e-16,-1.15185205123991e-16)
    sum e = 2.592001537861733
    sum de = -5.050433948003766e-19
Info: CFL hydro = 0.011142155321974767 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011142155321974767 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8874e+04 |  512 |      1 | 2.713e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1478.7444569576546 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.857085390975634, dt = 0.011142155321974767 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1557.00 ns (0.5%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 860.00 ns  (0.3%)
   LB compute        : 278.45 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.7429230761710778e-17,-7.594193828473761e-17,-2.1574539030289054e-18)
    sum a = (-1.1938887378715178e-16,2.550010983620732e-17,2.604752351309525e-17)
    sum e = 2.5920015372975858
    sum de = -7.343775652694784e-19
Info: CFL hydro = 0.01114166763346352 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114166763346352 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9788e+04 |  512 |      1 | 2.587e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1550.2623430161216 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.868227546297607, dt = 0.01114166763346352 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.4%)
   patch tree reduce : 1210.00 ns (0.4%)
   gen split merge   : 1107.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 295.86 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.23 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5734297505464188e-17,-7.640189750388743e-17,-1.1372738688286698e-18)
    sum a = (-2.0934035754871517e-16,4.183762711273964e-17,-5.410320629006815e-17)
    sum e = 2.5920015360489614
    sum de = 3.9559085614735996e-19
Info: CFL hydro = 0.011141412611001001 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011141412611001001 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9555e+04 |  512 |      1 | 2.618e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.9282885169043 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.87936921393107, dt = 0.011141412611001001 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.69 us    (1.6%)
   patch tree reduce : 1412.00 ns (0.5%)
   gen split merge   : 750.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 891.00 ns  (0.3%)
   LB compute        : 283.21 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1829.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2768896143499084e-17,-7.569677306848432e-17,-2.2613746812616407e-18)
    sum a = (-6.168503208225928e-17,-2.540936211437028e-17,-8.442465476710125e-18)
    sum e = 2.5920015342293956
    sum de = 1.183622664669478e-18
Info: CFL hydro = 0.011141411270133815 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011141411270133815 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9963e+04 |  512 |      1 | 2.565e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1563.8746390248061 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.89051062654207, dt = 0.011141411270133815 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.63 us    (1.3%)
   patch tree reduce : 1560.00 ns (0.5%)
   gen split merge   : 648.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 794.00 ns  (0.3%)
   LB compute        : 270.22 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1825.00 ns (63.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3035284617278772e-17,-7.646812870409913e-17,-2.2408832602016646e-18)
    sum a = (1.5468095554416195e-17,-2.2733767993110553e-17,-1.2611005989482394e-17)
    sum e = 2.592001531990998
    sum de = -2.5228876333969336e-18
Info: CFL hydro = 0.011141683838763086 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011141683838763086 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9335e+04 |  512 |      1 | 2.648e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1514.6655757179733 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.901652037812205, dt = 0.011141683838763086 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.5%)
   patch tree reduce : 2.07 us    (0.7%)
   gen split merge   : 664.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 970.00 ns  (0.3%)
   LB compute        : 271.50 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3595871350562403e-17,-7.67813547117302e-17,-2.160381248894616e-18)
    sum a = (-1.0181308920942377e-16,4.130485016518026e-18,-5.900943796099955e-17)
    sum e = 2.592001529518407
    sum de = -2.202285662861181e-19
Info: CFL hydro = 0.011142248022642848 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011142248022642848 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9358e+04 |  512 |      1 | 2.645e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1516.5426080343857 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.912793721650967, dt = 0.011142248022642848 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.5%)
   patch tree reduce : 1442.00 ns (0.5%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 885.00 ns  (0.3%)
   LB compute        : 273.76 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1970.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.1855564233397295e-17,-7.629504937978898e-17,-2.909781790516597e-18)
    sum a = (9.730497657622906e-18,9.098264134276002e-17,8.432219766180138e-17)
    sum e = 2.592001527008693
    sum de = -5.056786695108173e-19
Info: CFL hydro = 0.011142213081881123 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011142213081881123 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9274e+04 |  512 |      1 | 2.656e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.038479371366 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 19.92393596967361, dt = 0.011142213081881123 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 1417.00 ns (0.5%)
   gen split merge   : 731.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 280.39 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1755.00 ns (64.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2537635820107925e-17,-7.495029987272805e-17,-1.2733954515842249e-18)
    sum a = (9.01505432804317e-17,-5.807991416907806e-17,-9.169325455166133e-17)
    sum e = 2.592001524652095
    sum de = 2.371692252312041e-19
Info: CFL hydro = 0.01114251452044684 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114251452044684 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9621e+04 |  512 |      1 | 2.609e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.1887975654224 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.935078182755493, dt = 0.01114251452044684 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.4%)
   patch tree reduce : 1459.00 ns (0.5%)
   gen split merge   : 667.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1193.00 ns (0.4%)
   LB compute        : 296.73 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1898.00 ns (64.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.4315998433527274e-17,-7.640628852268599e-17,-3.100059271787803e-18)
    sum a = (-3.2575504793630474e-17,-4.228624286665983e-17,-2.797078974686729e-17)
    sum e = 2.5920015226404005
    sum de = 8.133633876009419e-19
Info: CFL hydro = 0.011143229618848755 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011143229618848755 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9725e+04 |  512 |      1 | 2.596e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1545.3325771350105 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.94622069727594, dt = 0.011143229618848755 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.4%)
   patch tree reduce : 1249.00 ns (0.4%)
   gen split merge   : 656.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1346.00 ns (0.4%)
   LB compute        : 297.90 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1920.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.296941933530028e-17,-7.702395850035098e-17,-3.10737763645208e-18)
    sum a = (4.859394137080031e-18,-1.0636511203060417e-17,-6.153573744310803e-17)
    sum e = 2.5920015211300877
    sum de = 1.4166626042828173e-19
Info: CFL hydro = 0.01114438400676506 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114438400676506 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0010e+04 |  512 |      1 | 2.559e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1567.764170207698 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 19.95736392689479, dt = 0.01114438400676506 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.93 us    (1.6%)
   patch tree reduce : 1608.00 ns (0.5%)
   gen split merge   : 804.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 926.00 ns  (0.3%)
   LB compute        : 294.27 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.71 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.513671875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.327971799706563e-17,-7.686734549653546e-17,-3.864096542738338e-18)
    sum a = (-1.2700582772973146e-16,2.4335026181654395e-17,1.1161969785955517e-16)
    sum e = 2.5920015202387217
    sum de = -1.2944781016413845e-18
Info: CFL hydro = 0.011145999568554528 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011145999568554528 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9757e+04 |  512 |      1 | 2.591e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1548.1473115826284 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.968508310901555, dt = 0.011145999568554528 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.56 us    (1.6%)
   patch tree reduce : 1330.00 ns (0.5%)
   gen split merge   : 596.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1133.00 ns (0.4%)
   LB compute        : 276.82 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1942.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.1239357928665157e-17,-7.648459502459376e-17,-1.790071996882192e-18)
    sum a = (8.884494702432465e-18,-8.558681107578847e-17,-2.2713276572050577e-17)
    sum e = 2.5920015200374373
    sum de = -5.117137792600042e-19
Info: CFL hydro = 0.011148094503792692 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011148094503792692 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9621e+04 |  512 |      1 | 2.609e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.675768924954 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 19.97965431047011, dt = 0.011148094503792692 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1447.00 ns (0.5%)
   gen split merge   : 679.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 933.00 ns  (0.3%)
   LB compute        : 279.93 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1859.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.211317066957985e-17,-7.777262720550654e-17,-2.941982595039416e-18)
    sum a = (-2.4731681546458217e-17,-7.443069598156437e-17,-3.81345345926154e-17)
    sum e = 2.592001520546151
    sum de = 3.1750500632235414e-19
Info: CFL hydro = 0.011150683065003693 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011150683065003693 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9490e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.7404698667233 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 19.990802404973902, dt = 0.009197595026098071 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.88 us    (1.7%)
   patch tree reduce : 1190.00 ns (0.4%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 807.00 ns  (0.3%)
   LB compute        : 276.93 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1799.00 ns (63.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.154233822576623e-17,-7.843384145292398e-17,-3.2552086026704786e-18)
    sum a = (-1.5972330879784891e-18,-1.586035990042145e-17,2.287281692173182e-17)
    sum e = 2.592001509638502
    sum de = 1.5868103475625249e-18
Info: CFL hydro = 0.011153272332223407 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011153272332223407 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9813e+04 |  512 |      1 | 2.584e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1281.2899467917855 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 2158                                                    [SPH][rank=0]
Info: time since start : 1816.311856367 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.1499157688696303 max=0.15008329516705646 delta=0.0001675262974261682
Number of particle pairs: 130816
Distance min=0.128515 max=1.940449 mean=0.800539
---------------- t = 20, dt = 0.011153272332223407 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 8.37 us    (1.3%)
   patch tree reduce : 1780.00 ns (0.3%)
   gen split merge   : 658.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 850.00 ns  (0.1%)
   LB compute        : 641.99 us  (96.5%)
   LB move op cnt    : 0
   LB apply          : 5.39 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (79.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.1775062222090245e-17,-7.853849406762314e-17,-2.8190340686795602e-18)
    sum a = (-5.868596624283851e-17,2.244688809827089e-17,-2.0280652157644853e-17)
    sum e = 2.592001522819232
    sum de = -2.0938654456126304e-18
Info: CFL hydro = 0.0111567087779297 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0111567087779297 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6488e+04 |  512 |      1 | 3.105e-02 | 0.1% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1293.0287904973156 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.011153272332223, dt = 0.0111567087779297 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.93 us    (1.3%)
   patch tree reduce : 1580.00 ns (0.5%)
   gen split merge   : 789.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1062.00 ns (0.3%)
   LB compute        : 276.14 us  (90.5%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.1114945729372448e-17,-7.796839346027595e-17,-3.351811016238937e-18)
    sum a = (-1.20065090682131e-16,5.848837039690302e-18,6.519199242938089e-18)
    sum e = 2.592001525153161
    sum de = -2.5707449949168015e-19
Info: CFL hydro = 0.01116072967598393 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01116072967598393 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8909e+04 |  512 |      1 | 2.708e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1483.3525695170024 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.02230998111015, dt = 0.01116072967598393 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.4%)
   patch tree reduce : 1342.00 ns (0.4%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1288.00 ns (0.4%)
   LB compute        : 285.17 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1936.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.903213914591917e-17,-7.78534951350468e-17,-3.029802971010742e-18)
    sum a = (-1.6650743284163382e-17,5.933730069795917e-17,1.7601398854052984e-17)
    sum e = 2.5920015276782014
    sum de = 1.5670109524204556e-19
Info: CFL hydro = 0.011165256556267577 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011165256556267577 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9151e+04 |  512 |      1 | 2.673e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1502.8721374382076 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.033470710786137, dt = 0.011165256556267577 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.5%)
   patch tree reduce : 1789.00 ns (0.6%)
   gen split merge   : 776.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 973.00 ns  (0.3%)
   LB compute        : 279.06 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9305845984363134e-17,-7.698919626819567e-17,-2.9024634258523195e-18)
    sum a = (-1.8699885390160986e-17,-1.8137249514771358e-16,7.332269557139282e-17)
    sum e = 2.592001530372293
    sum de = -1.2764786515122306e-18
Info: CFL hydro = 0.011170280875635277 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011170280875635277 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9391e+04 |  512 |      1 | 2.640e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1522.3355820500208 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.044635967342405, dt = 0.011170280875635277 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1380.00 ns (0.5%)
   gen split merge   : 771.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1028.00 ns (0.3%)
   LB compute        : 284.25 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1956.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9572234458142822e-17,-8.038272196302099e-17,-1.473918643385419e-18)
    sum a = (-1.1285503781488515e-16,8.148559951792755e-17,-3.34317534593509e-17)
    sum e = 2.5920015330480846
    sum de = 1.9651164376299768e-19
Info: CFL hydro = 0.011175789348766967 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011175789348766967 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9393e+04 |  512 |      1 | 2.640e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.172808734236 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.05580624821804, dt = 0.011175789348766967 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1083.00 ns (0.3%)
   gen split merge   : 698.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1028.00 ns (0.3%)
   LB compute        : 302.01 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1940.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7618231092780824e-17,-7.804157710691873e-17,-2.5380088655713172e-18)
    sum a = (-1.9870823736445332e-17,5.3336241673251905e-17,-1.0860471457698958e-16)
    sum e = 2.5920015355228196
    sum de = 8.538092108323347e-19
Info: CFL hydro = 0.0111817637990237 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0111817637990237 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7410e+04 |  512 |      1 | 2.941e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1368.1046184895404 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.066982037566806, dt = 0.0111817637990237 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 1314.00 ns (0.4%)
   gen split merge   : 736.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 925.00 ns  (0.3%)
   LB compute        : 277.67 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7894865277090498e-17,-7.784398126098325e-17,-4.117311960122327e-18)
    sum a = (-8.301952875156005e-18,-2.489414924200517e-17,-5.338747022590185e-17)
    sum e = 2.592001537630755
    sum de = -9.571472303973594e-19
Info: CFL hydro = 0.011188181307583431 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011188181307583431 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9201e+04 |  512 |      1 | 2.667e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.6164430913905 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.07816380136583, dt = 0.011188181307583431 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 1155.00 ns (0.4%)
   gen split merge   : 688.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 956.00 ns  (0.3%)
   LB compute        : 278.63 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.36 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.808367908542885e-17,-7.843530512585683e-17,-4.240260486482183e-18)
    sum a = (-6.0771700172157494e-18,-1.379833747261472e-16,-4.8757872739280116e-17)
    sum e = 2.592001539236474
    sum de = 1.3925221652860698e-18
Info: CFL hydro = 0.011195014244048772 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011195014244048772 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9493e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.4183838149236 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.089351982673413, dt = 0.011195014244048772 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1733.00 ns (0.6%)
   gen split merge   : 682.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 936.00 ns  (0.3%)
   LB compute        : 277.26 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1962.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8055869299704597e-17,-8.055909455143006e-17,-4.8754945393414405e-18)
    sum a = (8.380405744357056e-17,2.1174078115859806e-16,2.32182437338857e-17)
    sum e = 2.592001540244209
    sum de = -1.1011428314305904e-18
Info: CFL hydro = 0.011202230502882651 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011202230502882651 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8730e+04 |  512 |      1 | 2.734e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1474.3164386576962 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.100546996917462, dt = 0.011202230502882651 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.12 us    (1.7%)
   patch tree reduce : 1231.00 ns (0.4%)
   gen split merge   : 1067.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 944.00 ns  (0.3%)
   LB compute        : 281.85 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9548815691217138e-17,-7.592510604600977e-17,-4.285634347400702e-18)
    sum a = (2.837183613046967e-17,5.667341596016229e-17,1.051326994211399e-16)
    sum e = 2.5920015406054886
    sum de = 0
Info: CFL hydro = 0.011203192910179311 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011203192910179311 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8885e+04 |  512 |      1 | 2.711e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1487.4756695803462 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.111749227420344, dt = 0.011203192910179311 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 1182.00 ns (0.4%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1030.00 ns (0.3%)
   LB compute        : 283.50 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9537106307754294e-17,-7.646959237703199e-17,-2.621438222744077e-18)
    sum a = (4.3137368677115264e-17,4.4460529008416574e-17,4.0649124691261026e-17)
    sum e = 2.5920015402636136
    sum de = -2.1175823681357508e-19
Info: CFL hydro = 0.01120451016456524 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01120451016456524 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8964e+04 |  512 |      1 | 2.700e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1493.8373428328011 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.122952420330524, dt = 0.01120451016456524 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.3%)
   patch tree reduce : 1517.00 ns (0.5%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 910.00 ns  (0.3%)
   LB compute        : 319.29 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.45 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.013721221022502e-17,-7.595145215880117e-17,-2.8131793769481383e-18)
    sum a = (6.901510612999928e-17,-8.897960493414736e-17,2.59670215017882e-17)
    sum e = 2.5920015393350555
    sum de = -5.183841637196318e-19
Info: CFL hydro = 0.011206445658065318 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011206445658065318 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9135e+04 |  512 |      1 | 2.676e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1507.4896446628586 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.134156930495088, dt = 0.011206445658065318 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.5%)
   patch tree reduce : 1766.00 ns (0.6%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 950.00 ns  (0.3%)
   LB compute        : 280.18 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.116178326322382e-17,-7.777518863313904e-17,-2.489707658787088e-18)
    sum a = (1.1229298740866867e-17,3.792669303614993e-17,-3.350786445185938e-17)
    sum e = 2.592001537924874
    sum de = -2.998496633280223e-19
Info: CFL hydro = 0.011204410887883723 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011204410887883723 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8787e+04 |  512 |      1 | 2.725e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1480.3614087971157 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.145363376153153, dt = 0.011204410887883723 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.6%)
   patch tree reduce : 1323.00 ns (0.4%)
   gen split merge   : 713.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1273.00 ns (0.4%)
   LB compute        : 279.58 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.40 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0801719721741385e-17,-7.680623715158874e-17,-3.2493539109390567e-18)
    sum a = (-4.009292897677596e-17,1.701373417151153e-17,1.651945182208625e-16)
    sum e = 2.592001536133859
    sum de = -7.657177843178875e-19
Info: CFL hydro = 0.01120296996697045 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01120296996697045 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9772e+04 |  512 |      1 | 2.590e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1557.6495083627526 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.156567787041038, dt = 0.01120296996697045 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.4%)
   patch tree reduce : 1415.00 ns (0.4%)
   gen split merge   : 827.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 870.00 ns  (0.3%)
   LB compute        : 297.71 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.993522534549097e-17,-7.676086329067023e-17,-4.2739249639378587e-19)
    sum a = (5.257513174816708e-17,7.109937638638541e-17,-1.03086484661008e-17)
    sum e = 2.592001534169921
    sum de = -2.168404344971009e-19
Info: CFL hydro = 0.01120210292983796 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01120210292983796 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9535e+04 |  512 |      1 | 2.621e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1538.772799232802 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.167770757008007, dt = 0.01120210292983796 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.4%)
   patch tree reduce : 1079.00 ns (0.4%)
   gen split merge   : 688.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1103.00 ns (0.4%)
   LB compute        : 271.68 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.71 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1854.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.133156932343505e-17,-7.556065148572877e-17,-1.2894958538456346e-18)
    sum a = (-4.3980444286439987e-17,1.0799564367780511e-16,-3.8762450280810376e-17)
    sum e = 2.592001532212098
    sum de = 3.4558944247975454e-19
Info: CFL hydro = 0.011199887928372251 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011199887928372251 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9440e+04 |  512 |      1 | 2.634e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.2200343266318 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.178972859937847, dt = 0.011199887928372251 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.85 us    (1.7%)
   patch tree reduce : 1164.00 ns (0.4%)
   gen split merge   : 680.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1384.00 ns (0.5%)
   LB compute        : 274.87 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.45 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0119648135030754e-17,-7.4140888740859e-17,-1.8764286999206624e-18)
    sum a = (5.306692585360651e-17,-9.214113846911509e-17,-6.598237581312283e-17)
    sum e = 2.592001530424451
    sum de = 1.6534083130403943e-18
Info: CFL hydro = 0.011197335458926727 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011197335458926727 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9175e+04 |  512 |      1 | 2.670e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.9883260158874 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.19017274786622, dt = 0.011197335458926727 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.5%)
   patch tree reduce : 1188.00 ns (0.4%)
   gen split merge   : 709.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1021.00 ns (0.3%)
   LB compute        : 282.16 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1973.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.1270095060255122e-17,-7.638909036572494e-17,-2.741459403238222e-18)
    sum a = (-2.2552272549436482e-17,9.509190310175164e-17,4.2573854597965924e-17)
    sum e = 2.592001528978323
    sum de = -7.487771253728015e-19
Info: CFL hydro = 0.011195309081689413 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011195309081689413 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8987e+04 |  512 |      1 | 2.697e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1494.8603117835526 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.20137008332515, dt = 0.011195309081689413 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.5%)
   patch tree reduce : 1226.00 ns (0.4%)
   gen split merge   : 681.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 975.00 ns  (0.3%)
   LB compute        : 282.45 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0365545187750467e-17,-7.413503404912758e-17,-1.6568777599923479e-18)
    sum a = (1.114382024158811e-16,2.373492027918367e-17,-1.1384301704456256e-16)
    sum e = 2.592001528014277
    sum de = -1.2281977735187355e-18
Info: CFL hydro = 0.011193844219560947 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011193844219560947 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9713e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1551.7095050722305 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.212565392406837, dt = 0.011193844219560947 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1148.00 ns (0.4%)
   gen split merge   : 745.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 913.00 ns  (0.3%)
   LB compute        : 292.99 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.248494359452513e-17,-7.428725603414454e-17,-3.9270344788511215e-18)
    sum a = (7.399744879343917e-17,-6.728211737749845e-17,8.078157283722409e-17)
    sum e = 2.5920015276278905
    sum de = 9.232659125071874e-19
Info: CFL hydro = 0.011192796276325415 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011192796276325415 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9351e+04 |  512 |      1 | 2.646e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.0360668768649 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.2237592366264, dt = 0.011192796276325415 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.5%)
   patch tree reduce : 1655.00 ns (0.5%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 980.00 ns  (0.3%)
   LB compute        : 292.36 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1998.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.30967588804587e-17,-7.564261716996867e-17,-1.797390361546469e-18)
    sum a = (4.356476117350905e-17,1.0409641898467825e-17,-6.42918335756748e-17)
    sum e = 2.5920015278675397
    sum de = -5.319366908757006e-19
Info: CFL hydro = 0.011191150251209401 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011191150251209401 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9216e+04 |  512 |      1 | 2.664e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1512.279929734739 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.234952032902726, dt = 0.011191150251209401 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.3%)
   patch tree reduce : 1149.00 ns (0.4%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 937.00 ns  (0.3%)
   LB compute        : 297.69 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3310455128655594e-17,-7.5244498132232e-17,-3.2947277718575752e-18)
    sum a = (-5.1638381071139605e-18,-9.534950953793419e-17,7.925349829532302e-17)
    sum e = 2.592001528726447
    sum de = -1.4568966692773966e-19
Info: CFL hydro = 0.011189962502500391 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011189962502500391 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9399e+04 |  512 |      1 | 2.639e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1526.4720774327927 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.246143183153936, dt = 0.011189962502500391 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.5%)
   patch tree reduce : 1121.00 ns (0.4%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1031.00 ns (0.3%)
   LB compute        : 295.76 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3082122151130148e-17,-7.657936784699614e-17,-1.7037152938437217e-18)
    sum a = (-4.4887921504810354e-17,-8.650892502348739e-17,1.0041528155854684e-16)
    sum e = 2.5920015301611947
    sum de = 1.7279472123987727e-19
Info: CFL hydro = 0.011186515871447247 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011186515871447247 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9306e+04 |  512 |      1 | 2.652e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.9809343197444 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.257333145656435, dt = 0.011186515871447247 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.89 us    (1.6%)
   patch tree reduce : 1355.00 ns (0.5%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1341.00 ns (0.5%)
   LB compute        : 278.50 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.230930284258248e-17,-7.762443032105492e-17,-3.0005295123536336e-19)
    sum a = (1.0740431981293153e-17,9.75860017793373e-17,-3.7909128960955664e-19)
    sum e = 2.592001532056035
    sum de = 3.1509625637859973e-19
Info: CFL hydro = 0.011183669795194648 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011183669795194648 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9032e+04 |  512 |      1 | 2.690e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1496.957707557463 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.268519661527883, dt = 0.011183669795194648 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.3%)
   patch tree reduce : 1157.00 ns (0.4%)
   gen split merge   : 907.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 943.00 ns  (0.3%)
   LB compute        : 300.54 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2640092925407805e-17,-7.516838713972352e-17,-9.455327146246084e-19)
    sum a = (4.534641705102732e-17,-4.435514455725098e-17,3.901347018879509e-17)
    sum e = 2.5920015342951044
    sum de = 2.812149384884277e-19
Info: CFL hydro = 0.011181544262722045 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011181544262722045 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9310e+04 |  512 |      1 | 2.651e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.4606509210657 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.279703331323077, dt = 0.011181544262722045 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.4%)
   patch tree reduce : 1438.00 ns (0.5%)
   gen split merge   : 746.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 876.00 ns  (0.3%)
   LB compute        : 299.99 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3506587301658222e-17,-7.674037186961024e-17,-3.7177292494527945e-19)
    sum a = (1.7997761484270235e-16,-5.611722024567723e-17,-8.119432860428932e-17)
    sum e = 2.592001536717506
    sum de = -6.962610826430349e-19
Info: CFL hydro = 0.01118019967961777 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01118019967961777 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9415e+04 |  512 |      1 | 2.637e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1526.3975491900915 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.2908848755858, dt = 0.01118019967961777 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 1551.00 ns (0.5%)
   gen split merge   : 770.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1238.00 ns (0.4%)
   LB compute        : 287.01 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.39 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.6296347911680673e-17,-7.723802066678109e-17,-1.877892372853518e-18)
    sum a = (1.0506244312036284e-17,-9.434835725186109e-17,1.4821225301740737e-16)
    sum e = 2.592001539146844
    sum de = 5.230428449295305e-19
Info: CFL hydro = 0.011179688020712081 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011179688020712081 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9689e+04 |  512 |      1 | 2.600e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1547.7542312092319 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.302065075265418, dt = 0.011179688020712081 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1129.00 ns (0.4%)
   gen split merge   : 836.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1088.00 ns (0.3%)
   LB compute        : 297.50 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5324469084264667e-17,-7.8666565449248e-17,1.1636199816200676e-18)
    sum a = (-1.1867460139591834e-17,1.2142923385555227e-16,4.99694280094512e-17)
    sum e = 2.59200154140522
    sum de = -9.08284017252627e-19
Info: CFL hydro = 0.011179791928041612 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011179791928041612 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9485e+04 |  512 |      1 | 2.628e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.6694423899935 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.31324476328613, dt = 0.011179791928041612 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.56 us    (1.6%)
   patch tree reduce : 1300.00 ns (0.4%)
   gen split merge   : 724.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1234.00 ns (0.4%)
   LB compute        : 276.88 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5175174445113412e-17,-7.630419733561933e-17,9.64560462751729e-19)
    sum a = (6.904437958865639e-17,5.022740036386697e-17,-4.922917542365956e-17)
    sum e = 2.5920015433251
    sum de = 5.166900978251232e-20
Info: CFL hydro = 0.011180715965576222 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011180715965576222 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8954e+04 |  512 |      1 | 2.701e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1489.9568546009973 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.32442455521417, dt = 0.011180715965576222 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.3%)
   patch tree reduce : 2.33 us    (0.7%)
   gen split merge   : 960.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1052.00 ns (0.3%)
   LB compute        : 301.93 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.38 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.6275856490620697e-17,-7.581533057604562e-17,-1.463672932855431e-21)
    sum a = (8.899716900934163e-17,3.375238931120454e-17,1.8722069183049575e-17)
    sum e = 2.592001544767266
    sum de = 6.835555884342204e-19
Info: CFL hydro = 0.011182607957022708 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011182607957022708 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9364e+04 |  512 |      1 | 2.644e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1522.311758018852 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.335605271179745, dt = 0.011182607957022708 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.5%)
   patch tree reduce : 1480.00 ns (0.5%)
   gen split merge   : 692.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1154.00 ns (0.4%)
   LB compute        : 277.09 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.7499487062487838e-17,-7.564554451583438e-17,4.88866759573714e-19)
    sum a = (-1.251089076087508e-16,-6.056971330742345e-17,3.2066512531229994e-17)
    sum e = 2.592001545626868
    sum de = -1.020674701441432e-18
Info: CFL hydro = 0.011184174329952386 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011184174329952386 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8017e+04 |  512 |      1 | 2.842e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1416.656208628712 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.346787879136766, dt = 0.011184174329952386 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.70 us    (1.6%)
   patch tree reduce : 1297.00 ns (0.4%)
   gen split merge   : 777.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 975.00 ns  (0.3%)
   LB compute        : 281.05 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.4990751655573628e-17,-7.6702316373356e-17,8.38684590526162e-19)
    sum a = (1.9203388879063254e-18,2.299722912102453e-17,-2.6038741475498116e-17)
    sum e = 2.592001545831473
    sum de = -1.9142944607947188e-19
Info: CFL hydro = 0.011181296144171014 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011181296144171014 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9056e+04 |  512 |      1 | 2.687e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1498.5713498510397 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.357972053466717, dt = 0.011181296144171014 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.59 us    (1.5%)
   patch tree reduce : 1407.00 ns (0.5%)
   gen split merge   : 786.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 920.00 ns  (0.3%)
   LB compute        : 284.42 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.73 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.564940447535857e-17,-7.63246887566793e-17,1.6685871434551912e-19)
    sum a = (-9.224652292028068e-17,8.42490140151586e-17,1.4612944643395408e-17)
    sum e = 2.592001545333096
    sum de = 1.2027867851011065e-18
Info: CFL hydro = 0.011179086569426473 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011179086569426473 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9205e+04 |  512 |      1 | 2.666e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.8368684875024 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.369153349610887, dt = 0.011179086569426473 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.5%)
   patch tree reduce : 1196.00 ns (0.4%)
   gen split merge   : 743.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1043.00 ns (0.4%)
   LB compute        : 267.67 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.505859375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.421500500116025e-17,-7.51361863352007e-17,4.742300302451596e-19)
    sum a = (1.699734103466355e-16,-6.212998865384733e-17,1.2532699487574628e-17)
    sum e = 2.5920015442189976
    sum de = 5.421010862427522e-20
Info: CFL hydro = 0.01117755239655279 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01117755239655279 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8434e+04 |  512 |      1 | 2.778e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1448.9408470723083 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.380332436180314, dt = 0.01117755239655279 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.59 us    (1.5%)
   patch tree reduce : 1245.00 ns (0.4%)
   gen split merge   : 689.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1034.00 ns (0.3%)
   LB compute        : 279.27 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.32 us    (70.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.7379465881993693e-17,-7.617246677166234e-17,6.68898530314932e-19)
    sum a = (-1.827834758549862e-17,5.336551513190901e-17,-1.7629940476243668e-18)
    sum e = 2.59200154257847
    sum de = -3.9132922163148676e-19
Info: CFL hydro = 0.011176692934848055 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011176692934848055 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9539e+04 |  512 |      1 | 2.620e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1535.6135629769399 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.391509988576868, dt = 0.011176692934848055 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.42 us    (1.9%)
   patch tree reduce : 1386.00 ns (0.5%)
   gen split merge   : 743.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 944.00 ns  (0.3%)
   LB compute        : 269.83 us  (93.6%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.00 us    (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.6144125926663708e-17,-7.52474254780977e-17,5.1960389116367795e-19)
    sum a = (-1.063212018426185e-17,-1.3493308033407647e-16,-7.333074577252352e-17)
    sum e = 2.5920015405414794
    sum de = -1.2807138162485021e-18
Info: CFL hydro = 0.011176499471442851 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011176499471442851 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9816e+04 |  512 |      1 | 2.584e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1557.2306487262656 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.402686681511717, dt = 0.011176499471442851 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.04 us    (1.7%)
   patch tree reduce : 1726.00 ns (0.6%)
   gen split merge   : 941.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 974.00 ns  (0.3%)
   LB compute        : 283.30 us  (93.7%)
   LB move op cnt    : 0
   LB apply          : 3.75 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.6155835310126552e-17,-7.784983595271466e-17,-4.830120678422922e-19)
    sum a = (5.859375484806862e-17,3.6673789005625676e-17,3.1351874221763333e-17)
    sum e = 2.592001538269356
    sum de = 1.7618285302889447e-19
Info: CFL hydro = 0.011176955074337509 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011176955074337509 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9651e+04 |  512 |      1 | 2.605e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1544.278266602478 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.41386318098316, dt = 0.011176955074337509 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.97 us    (1.6%)
   patch tree reduce : 1777.00 ns (0.6%)
   gen split merge   : 798.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 923.00 ns  (0.3%)
   LB compute        : 284.65 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.729750019775379e-17,-7.638323567399352e-17,4.2007413172950867e-19)
    sum a = (-2.795029832580731e-17,1.673387990674957e-16,-1.3046448687006884e-16)
    sum e = 2.5920015359441346
    sum de = 1.6771252355635147e-18
Info: CFL hydro = 0.011178034692713938 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011178034692713938 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8787e+04 |  512 |      1 | 2.725e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1476.4054318258886 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.425040136057497, dt = 0.011178034692713938 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.3%)
   patch tree reduce : 1174.00 ns (0.4%)
   gen split merge   : 885.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 912.00 ns  (0.3%)
   LB compute        : 292.35 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.6477843355354747e-17,-7.377789785351085e-17,-1.997913553347663e-18)
    sum a = (-2.6147053272529418e-17,-6.6275110399693915e-18,8.325518009374977e-17)
    sum e = 2.5920015337540403
    sum de = -2.4292904927253334e-18
Info: CFL hydro = 0.011179396102752471 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011179396102752471 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9386e+04 |  512 |      1 | 2.641e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.6667793779386 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.436218170750212, dt = 0.011179396102752471 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.5%)
   patch tree reduce : 1420.00 ns (0.5%)
   gen split merge   : 756.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 876.00 ns  (0.3%)
   LB compute        : 293.46 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1991.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.59801945581839e-17,-7.470001180120977e-17,1.141664887627236e-19)
    sum a = (4.472984482806197e-17,-8.676653145966995e-17,-4.666189309943114e-17)
    sum e = 2.592001531876931
    sum de = 3.7608262858090935e-19
Info: CFL hydro = 0.011176873267197102 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011176873267197102 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9287e+04 |  512 |      1 | 2.655e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1516.0293303901947 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.447397566852963, dt = 0.011176873267197102 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.02 us    (1.4%)
   patch tree reduce : 1117.00 ns (0.4%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 957.00 ns  (0.3%)
   LB compute        : 280.04 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.6993056227719857e-17,-7.614612065887094e-17,-1.0509171657901994e-18)
    sum a = (-1.4118003641150345e-16,1.0560692945138506e-16,7.887587067864632e-17)
    sum e = 2.5920015304452
    sum de = 9.825582188149884e-19
Info: CFL hydro = 0.011174720892965282 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011174720892965282 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9687e+04 |  512 |      1 | 2.601e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1547.1429720749072 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.45857444012016, dt = 0.011174720892965282 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.4%)
   patch tree reduce : 1414.00 ns (0.5%)
   gen split merge   : 741.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 994.00 ns  (0.3%)
   LB compute        : 288.93 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.435551760271437e-17,-7.388328230467644e-17,4.947214513051356e-19)
    sum a = (-1.7435271976173895e-17,1.2100476870502418e-16,1.1319314626237476e-16)
    sum e = 2.5920015296149743
    sum de = -5.658180087658726e-19
Info: CFL hydro = 0.011173264476410039 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011173264476410039 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9305e+04 |  512 |      1 | 2.652e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1516.855167167233 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.469749161013123, dt = 0.011173264476410039 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.3%)
   patch tree reduce : 1335.00 ns (0.4%)
   gen split merge   : 802.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 950.00 ns  (0.3%)
   LB compute        : 296.77 us  (91.0%)
   LB move op cnt    : 0
   LB apply          : 15.65 us   (4.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.4734608892323926e-17,-7.223518658228122e-17,2.0125502826762176e-18)
    sum a = (4.988197355171309e-18,-2.761072620538485e-17,-8.083426506280688e-17)
    sum e = 2.5920015294696044
    sum de = 1.8973538018496328e-19
Info: CFL hydro = 0.011172511590557805 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011172511590557805 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9256e+04 |  512 |      1 | 2.659e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1512.7981471672426 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.480922425489535, dt = 0.011172511590557805 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.5%)
   patch tree reduce : 1520.00 ns (0.5%)
   gen split merge   : 766.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 897.00 ns  (0.3%)
   LB compute        : 288.50 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (64.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.4838529670556664e-17,-7.345003511655124e-17,1.1709383462843448e-20)
    sum a = (-1.5095737160297773e-16,3.720071126145363e-17,3.8964437145544425e-17)
    sum e = 2.5920015300420687
    sum de = -3.6930636500287495e-19
Info: CFL hydro = 0.011172459012935145 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011172459012935145 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9409e+04 |  512 |      1 | 2.638e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1524.6825467607343 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.492094937080093, dt = 0.007905062919906669 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1182.00 ns (0.4%)
   gen split merge   : 775.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 976.00 ns  (0.3%)
   LB compute        : 276.18 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1936.00 ns (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.299722912102453e-17,-7.27679635298406e-17,1.008470650737392e-18)
    sum a = (-4.3798948842765916e-17,-1.5222198501696481e-18,-8.296098183424583e-18)
    sum e = 2.592001513241249
    sum de = -1.8973538018496328e-19
Info: CFL hydro = 0.011173006247443365 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011173006247443365 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9878e+04 |  512 |      1 | 2.576e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1104.8870464716656 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 2203                                                    [SPH][rank=0]
Info: time since start : 1818.145008416 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14991856921874125 max=0.15008164971420368 delta=0.00016308049546243097
Number of particle pairs: 130816
Distance min=0.127690 max=1.849749 mean=0.800536
---------------- t = 20.5, dt = 0.011173006247443365 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.65 us    (1.9%)
   patch tree reduce : 1537.00 ns (0.3%)
   gen split merge   : 538.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 888.00 ns  (0.2%)
   LB compute        : 485.87 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 4.16 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.71 us    (79.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2865498557067542e-17,-7.310168095853165e-17,5.576593874179192e-19)
    sum a = (2.3524151376852488e-17,4.9038897942388357e-17,-2.949008225117122e-17)
    sum e = 2.592001532080638
    sum de = 1.0503208545953324e-19
Info: CFL hydro = 0.011173942597993983 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011173942597993983 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6965e+04 |  512 |      1 | 3.018e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1332.759792828914 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.511173006247443, dt = 0.011173942597993983 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.85 us    (1.6%)
   patch tree reduce : 1199.00 ns (0.4%)
   gen split merge   : 750.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1135.00 ns (0.4%)
   LB compute        : 284.74 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3527078722718197e-17,-7.231129757478971e-17,1.9905951886833862e-19)
    sum a = (-1.1448264211622038e-16,5.607623740355727e-17,4.918819258153961e-17)
    sum e = 2.59200153459491
    sum de = -6.539094352803199e-19
Info: CFL hydro = 0.011175684374543207 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011175684374543207 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9463e+04 |  512 |      1 | 2.631e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.1409448947152 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.52234694884544, dt = 0.011175684374543207 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.00 us    (1.7%)
   patch tree reduce : 2.04 us    (0.7%)
   gen split merge   : 751.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1009.00 ns (0.3%)
   LB compute        : 283.90 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1930.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.1649186349864678e-17,-7.135991016843368e-17,1.18850242147861e-18)
    sum a = (-1.3711688034989678e-17,1.4829934155691228e-17,5.4278847042010804e-17)
    sum e = 2.592001537280305
    sum de = 1.7279472123987727e-19
Info: CFL hydro = 0.011178021811840357 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011178021811840357 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8987e+04 |  512 |      1 | 2.697e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1491.980650027455 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.53352263321998, dt = 0.011178021811840357 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.5%)
   patch tree reduce : 1752.00 ns (0.6%)
   gen split merge   : 867.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 913.00 ns  (0.3%)
   LB compute        : 285.67 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.1698951229581763e-17,-7.135698282256798e-17,1.687614891582312e-18)
    sum a = (7.441752292516868e-17,1.7258460285884957e-16,1.93497561723488e-18)
    sum e = 2.5920015402048957
    sum de = -9.147955830346444e-20
Info: CFL hydro = 0.011180903607298901 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011180903607298901 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9343e+04 |  512 |      1 | 2.647e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1520.29799164577 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 20.54470065503182, dt = 0.011180903607298901 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.3%)
   patch tree reduce : 1464.00 ns (0.5%)
   gen split merge   : 799.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1025.00 ns (0.3%)
   LB compute        : 292.44 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3355828989574112e-17,-6.890679433296798e-17,1.5134378125725156e-18)
    sum a = (6.219256067172691e-17,8.830046069330244e-17,-1.5144916570841716e-16)
    sum e = 2.592001543177516
    sum de = 1.5246593050577406e-19
Info: CFL hydro = 0.011184269449559789 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011184269449559789 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8949e+04 |  512 |      1 | 2.702e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1489.695366457947 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.555881558639122, dt = 0.011184269449559789 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.3%)
   patch tree reduce : 1358.00 ns (0.4%)
   gen split merge   : 775.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 979.00 ns  (0.3%)
   LB compute        : 308.00 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.56 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3710037839325126e-17,-6.829497904703441e-17,-9.601694439531627e-19)
    sum a = (8.813652932482263e-17,1.2467566042062562e-16,-5.28766483723353e-17)
    sum e = 2.59200154600415
    sum de = -1.0706496453294356e-18
Info: CFL hydro = 0.011187894447234057 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011187894447234057 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9639e+04 |  512 |      1 | 2.607e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1544.3626302741789 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.567065828088683, dt = 0.011187894447234057 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1642.00 ns (0.6%)
   gen split merge   : 1006.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1029.00 ns (0.4%)
   LB compute        : 276.23 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1927.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.477266438857817e-17,-6.655906294866787e-17,-9.77733519147428e-19)
    sum a = (-1.0489851175188303e-16,9.612232884648186e-17,-7.59207150272112e-17)
    sum e = 2.592001548499883
    sum de = 1.5924219408380846e-18
Info: CFL hydro = 0.011191555800701797 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011191555800701797 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8572e+04 |  512 |      1 | 2.757e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1461.0012219395219 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.578253722535916, dt = 0.011191555800701797 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.99 us    (1.7%)
   patch tree reduce : 1633.00 ns (0.5%)
   gen split merge   : 958.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1356.00 ns (0.4%)
   LB compute        : 283.10 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.39 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2531781128376503e-17,-6.559450248591613e-17,-1.790071996882192e-18)
    sum a = (1.6604783954071722e-16,1.5819377058301497e-17,-5.736134223860433e-17)
    sum e = 2.592001550502765
    sum de = -1.9142944607947188e-19
Info: CFL hydro = 0.011195852190193646 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011195852190193646 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9497e+04 |  512 |      1 | 2.626e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1534.260322211815 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.58944527833662, dt = 0.011195852190193646 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 1224.00 ns (0.4%)
   gen split merge   : 942.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 988.00 ns  (0.3%)
   LB compute        : 297.29 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1917.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.6258292415426432e-17,-6.587991870782295e-17,-2.3462677113672558e-18)
    sum a = (-6.953617369409581e-17,1.2111893519378692e-17,3.2373517928896424e-17)
    sum e = 2.5920015518941963
    sum de = 4.1504614415460717e-19
Info: CFL hydro = 0.011200771315303597 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011200771315303597 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9660e+04 |  512 |      1 | 2.604e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1547.6423801596584 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.600641130526814, dt = 0.011200771315303597 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 2.12 us    (0.7%)
   gen split merge   : 1023.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 912.00 ns  (0.3%)
   LB compute        : 275.66 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.40 us    (70.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.382127698222214e-17,-6.571159632054457e-17,-1.6627324517237696e-18)
    sum a = (5.597085295239168e-18,-9.274197620805224e-18,-7.51918059066492e-17)
    sum e = 2.5920015525947795
    sum de = -7.199780051661553e-19
Info: CFL hydro = 0.011205742003249175 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011205742003249175 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9098e+04 |  512 |      1 | 2.681e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1504.0539607511826 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.611841901842116, dt = 0.011205742003249175 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 1396.00 ns (0.5%)
   gen split merge   : 742.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1255.00 ns (0.4%)
   LB compute        : 282.33 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.72 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.426623355381019e-17,-6.605263211389988e-17,-2.9844291100922236e-18)
    sum a = (-6.703036563304732e-17,7.900321022380475e-17,-1.5441749441624797e-18)
    sum e = 2.5920015525698408
    sum de = 3.3966021184897444e-19
Info: CFL hydro = 0.011210367901368107 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011210367901368107 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8833e+04 |  512 |      1 | 2.719e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1483.8349178983608 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.623047643845364, dt = 0.011210367901368107 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1500.00 ns (0.5%)
   gen split merge   : 685.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1561.00 ns (0.5%)
   LB compute        : 281.56 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1959.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3225562098549978e-17,-6.448650207574458e-17,-2.5643549783627152e-18)
    sum a = (-5.532683686193529e-17,1.59013427425414e-17,-5.953636021682751e-17)
    sum e = 2.5920015518391977
    sum de = -1.2093512904423273e-18
Info: CFL hydro = 0.011214891162845969 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011214891162845969 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8630e+04 |  512 |      1 | 2.748e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1468.4443800343379 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.63425801174673, dt = 0.011214891162845969 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.4%)
   patch tree reduce : 1833.00 ns (0.6%)
   gen split merge   : 732.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 293.48 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.38 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.251421705318224e-17,-6.456261306825306e-17,-3.713338230654228e-18)
    sum a = (-4.5631467354700914e-17,-1.2942674276067434e-16,-2.6673975528357374e-17)
    sum e = 2.592001550479573
    sum de = 4.912791094074942e-19
Info: CFL hydro = 0.011219013770468184 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011219013770468184 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9369e+04 |  512 |      1 | 2.643e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.3608151332037 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.645472902909578, dt = 0.011219013770468184 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.3%)
   patch tree reduce : 1359.00 ns (0.4%)
   gen split merge   : 787.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 300.82 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.99 us    (1.3%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1996.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2010713564279972e-17,-6.693669056534456e-17,-3.7265112870499275e-18)
    sum a = (1.8103877771902255e-16,-3.3682041530869175e-17,-8.692314446348548e-17)
    sum e = 2.5920015486084145
    sum de = 8.004461351553138e-19
Info: CFL hydro = 0.01121798576551999 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01121798576551999 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9444e+04 |  512 |      1 | 2.633e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.8341939319912 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.656691916680046, dt = 0.01121798576551999 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.85 us    (1.3%)
   patch tree reduce : 2.04 us    (0.7%)
   gen split merge   : 881.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 798.00 ns  (0.3%)
   LB compute        : 273.45 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1965.00 ns (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.55762208287158e-17,-6.676983185099905e-17,-4.97502429877561e-18)
    sum a = (3.9847031924056253e-17,-5.417346259084521e-17,4.4498584504670815e-17)
    sum e = 2.592001546344163
    sum de = -3.4558944247975454e-19
Info: CFL hydro = 0.01121706157653042 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01121706157653042 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9682e+04 |  512 |      1 | 2.601e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1552.4796256539105 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.667909902445565, dt = 0.01121706157653042 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.23 us    (1.4%)
   patch tree reduce : 1355.00 ns (0.4%)
   gen split merge   : 733.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 811.00 ns  (0.3%)
   LB compute        : 287.24 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.503466184355929e-17,-6.751337770088961e-17,-3.670159879134993e-18)
    sum a = (5.045573334139242e-17,4.421463195569686e-17,6.068534346911902e-17)
    sum e = 2.5920015439160706
    sum de = 4.2690460541616737e-19
Info: CFL hydro = 0.011215865690006979 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011215865690006979 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9264e+04 |  512 |      1 | 2.658e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1519.3516244905106 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.679126964022096, dt = 0.011215865690006979 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.5%)
   patch tree reduce : 1874.00 ns (0.6%)
   gen split merge   : 740.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 889.00 ns  (0.3%)
   LB compute        : 288.38 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.5816263189704092e-17,-6.653271683587647e-17,-2.845380181470958e-18)
    sum a = (-5.529170871154676e-17,6.875749969381673e-17,8.201398544668837e-17)
    sum e = 2.5920015415126856
    sum de = 1.5754812818929986e-19
Info: CFL hydro = 0.011214059705604289 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011214059705604289 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9558e+04 |  512 |      1 | 2.618e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.396155729921 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.690342829712105, dt = 0.011214059705604289 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1366.00 ns (0.5%)
   gen split merge   : 700.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 869.00 ns  (0.3%)
   LB compute        : 275.74 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1944.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.4818038249496688e-17,-6.567207715135747e-17,-1.897651957447066e-18)
    sum a = (-4.481181051230187e-17,3.864096542738338e-18,8.617813494066206e-17)
    sum e = 2.592001539319075
    sum de = 1.4094628242311558e-18
Info: CFL hydro = 0.011212426469923526 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011212426469923526 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9474e+04 |  512 |      1 | 2.629e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1535.4682802711206 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.70155688941771, dt = 0.011212426469923526 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.99 us    (1.3%)
   patch tree reduce : 1698.00 ns (0.6%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 926.00 ns  (0.3%)
   LB compute        : 289.00 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.408034709133755e-17,-6.592675624167432e-17,-9.396780228931867e-19)
    sum a = (-1.4370926323947763e-16,-6.628681978315676e-17,-2.084065342175534e-16)
    sum e = 2.5920015375091654
    sum de = -2.371692252312041e-20
Info: CFL hydro = 0.011211005185950765 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011211005185950765 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9933e+04 |  512 |      1 | 2.569e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1571.442870493287 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.712769315887634, dt = 0.011211005185950765 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1339.00 ns (0.5%)
   gen split merge   : 737.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 943.00 ns  (0.3%)
   LB compute        : 278.33 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1844.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2110243323714142e-17,-6.7053784399973e-17,-4.876958212274296e-18)
    sum a = (3.1451403981197503e-17,-6.012768408170111e-17,1.0111052620165317e-17)
    sum e = 2.592001536219948
    sum de = -6.539094352803199e-19
Info: CFL hydro = 0.01120982972070217 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01120982972070217 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9548e+04 |  512 |      1 | 2.619e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1540.9516218105034 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.723980321073586, dt = 0.01120982972070217 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.49 us    (1.5%)
   patch tree reduce : 1567.00 ns (0.5%)
   gen split merge   : 721.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1487.00 ns (0.5%)
   LB compute        : 276.65 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3354365316641257e-17,-6.756606992647241e-17,-3.55892073623798e-18)
    sum a = (-4.367600031640606e-17,-3.464806566655376e-17,1.2142191549088799e-16)
    sum e = 2.5920015355484503
    sum de = 4.2351647362715017e-19
Info: CFL hydro = 0.011208926852495926 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011208926852495926 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9560e+04 |  512 |      1 | 2.618e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1541.714917412085 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.73519015079429, dt = 0.011208926852495926 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.5%)
   patch tree reduce : 1467.00 ns (0.5%)
   gen split merge   : 804.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 941.00 ns  (0.3%)
   LB compute        : 285.08 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1964.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.2405905256150936e-17,-6.788515062583489e-17,-1.5163651584382266e-18)
    sum a = (2.3289963707595616e-17,4.850026630309756e-17,-8.067765205899136e-17)
    sum e = 2.592001535543762
    sum de = 8.131516293641283e-19
Info: CFL hydro = 0.011208316334560469 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011208316334560469 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9357e+04 |  512 |      1 | 2.645e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1525.539954667411 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.746399077646785, dt = 0.011208316334560469 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.5%)
   patch tree reduce : 1253.00 ns (0.4%)
   gen split merge   : 766.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1019.00 ns (0.3%)
   LB compute        : 302.60 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.3055776038338747e-17,-6.695132729467312e-17,-3.793840241961277e-18)
    sum a = (-1.5910710249311676e-16,-3.7317805096082065e-17,1.8456915683306983e-18)
    sum e = 2.5920015362049655
    sum de = -4.980553729855286e-19
Info: CFL hydro = 0.01120801013180179 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01120801013180179 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9164e+04 |  512 |      1 | 2.672e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.3193259488035 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.757607393981345, dt = 0.01120801013180179 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 1337.00 ns (0.4%)
   gen split merge   : 798.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 952.00 ns  (0.3%)
   LB compute        : 283.42 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1936.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0312852962167672e-17,-6.77534200618779e-17,-3.1710474090312912e-18)
    sum a = (-9.23050698375949e-17,5.3757779477914266e-17,8.16714859804002e-17)
    sum e = 2.5920015374818317
    sum de = -1.8973538018496328e-19
Info: CFL hydro = 0.011208012058108638 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011208012058108638 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.3191e+04 |  512 |      1 | 3.881e-02 | 0.0% |   1.3% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1039.5464796691424 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.76881540411315, dt = 0.011208012058108638 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.4%)
   patch tree reduce : 1563.00 ns (0.5%)
   gen split merge   : 721.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 975.00 ns  (0.3%)
   LB compute        : 298.24 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1951.00 ns (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.959565322506851e-17,-6.676397715926763e-17,-1.798122198012897e-18)
    sum a = (4.0508612089706905e-17,8.477593627098656e-18,-4.658870945278837e-18)
    sum e = 2.592001539279359
    sum de = 6.505213034913027e-19
Info: CFL hydro = 0.011208317647157085 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011208317647157085 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9630e+04 |  512 |      1 | 2.608e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1546.9912901775351 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.780023416171257, dt = 0.011208317647157085 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.2%)
   patch tree reduce : 1280.00 ns (0.4%)
   gen split merge   : 617.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1408.00 ns (0.4%)
   LB compute        : 338.94 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 3.45 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (70.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0904176827041264e-17,-6.705671174583872e-17,-2.338217510236551e-18)
    sum a = (-4.696633706946507e-17,-1.0333530905959343e-16,5.799072159973218e-18)
    sum e = 2.5920015414655886
    sum de = 5.996993266560446e-19
Info: CFL hydro = 0.011208914199214317 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011208914199214317 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9691e+04 |  512 |      1 | 2.600e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1551.8221852258132 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.791231733818414, dt = 0.011208914199214317 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1554.00 ns (0.5%)
   gen split merge   : 759.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 922.00 ns  (0.3%)
   LB compute        : 275.07 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9952789420685236e-17,-6.856429486667981e-17,-2.3133350703780085e-18)
    sum a = (-8.508623493275192e-17,-2.768098250616191e-17,6.94512806639902e-18)
    sum e = 2.592001543881954
    sum de = -4.675621868843738e-19
Info: CFL hydro = 0.011207416926058658 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011207416926058658 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9497e+04 |  512 |      1 | 2.626e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.587512984026 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.80244064801763, dt = 0.011207416926058658 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.4%)
   patch tree reduce : 1307.00 ns (0.4%)
   gen split merge   : 628.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1557.00 ns (0.5%)
   LB compute        : 284.26 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1964.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8588646247263972e-17,-6.858185894187408e-17,-2.0645106717925854e-18)
    sum a = (1.7217477443765005e-16,-2.8746536401280663e-17,-5.915726892721795e-17)
    sum e = 2.5920015463379085
    sum de = -1.7889335846010823e-18
Info: CFL hydro = 0.01120334029253855 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01120334029253855 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8960e+04 |  512 |      1 | 2.700e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1494.089787504217 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.81364806494369, dt = 0.01120334029253855 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.5%)
   patch tree reduce : 1140.00 ns (0.4%)
   gen split merge   : 799.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1004.00 ns (0.3%)
   LB compute        : 281.82 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.44 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1934.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.1981440105622862e-17,-6.890093964123656e-17,-3.148360478572032e-18)
    sum a = (-1.9247152699755632e-16,-1.2646134139870923e-18,-5.722961167464735e-18)
    sum e = 2.5920015486529446
    sum de = 1.3552527156068805e-20
Info: CFL hydro = 0.011199422279452287 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011199422279452287 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9286e+04 |  512 |      1 | 2.655e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1519.203476113289 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.824851405236227, dt = 0.011199422279452287 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 1382.00 ns (0.5%)
   gen split merge   : 768.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 883.00 ns  (0.3%)
   LB compute        : 284.01 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.789193793122479e-17,-6.884532006978805e-17,-3.0671266307985555e-18)
    sum a = (2.0421164759198974e-17,-8.787892288864007e-17,-9.597157053439776e-17)
    sum e = 2.5920015506866543
    sum de = 5.21772295508649e-19
Info: CFL hydro = 0.011195735225551522 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011195735225551522 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9361e+04 |  512 |      1 | 2.644e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1524.6282404238982 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.83605082751568, dt = 0.011195735225551522 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.84 us    (1.2%)
   patch tree reduce : 2.21 us    (0.7%)
   gen split merge   : 796.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 995.00 ns  (0.3%)
   LB compute        : 311.36 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9408303089663014e-17,-7.020946324320931e-17,-4.633256668953867e-18)
    sum a = (-1.9147769307614747e-16,-1.3006783150526502e-16,-3.3484445684933693e-17)
    sum e = 2.592001552306178
    sum de = -2.371692252312041e-19
Info: CFL hydro = 0.011191438896145045 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011191438896145045 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9687e+04 |  512 |      1 | 2.601e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1549.7822177182004 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.847246562741233, dt = 0.011191438896145045 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.5%)
   patch tree reduce : 1292.00 ns (0.4%)
   gen split merge   : 688.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1030.00 ns (0.4%)
   LB compute        : 275.84 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1899.00 ns (64.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5787176253778678e-17,-7.182535816108171e-17,-4.638379524218861e-18)
    sum a = (1.3705833343258254e-16,8.477593627098656e-17,-6.13264322137097e-17)
    sum e = 2.592001553405262
    sum de = 1.0469327228063152e-18
Info: CFL hydro = 0.011185662541335312 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011185662541335312 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9774e+04 |  512 |      1 | 2.589e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1556.0081860333955 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.858438001637378, dt = 0.011185662541335312 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.3%)
   patch tree reduce : 1201.00 ns (0.4%)
   gen split merge   : 771.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 997.00 ns  (0.3%)
   LB compute        : 304.73 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9048239548180578e-17,-6.968839567911277e-17,-5.512192265133553e-18)
    sum a = (-1.1844041372666148e-16,-4.017489466101587e-17,-2.2110243323714142e-17)
    sum e = 2.5920015539199186
    sum de = 1.8295911660692887e-19
Info: CFL hydro = 0.011179952833872102 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011179952833872102 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9670e+04 |  512 |      1 | 2.603e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1547.0095647137948 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.869623664178715, dt = 0.011179952833872102 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.2%)
   patch tree reduce : 1237.00 ns (0.4%)
   gen split merge   : 647.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1036.00 ns (0.3%)
   LB compute        : 312.01 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.66829440886862e-17,-7.101155601041409e-17,-5.619772225698427e-18)
    sum a = (-2.8360126747006833e-17,-9.308959852960541e-18,-3.973872012702495e-18)
    sum e = 2.5920015538531005
    sum de = 3.6591823321385775e-19
Info: CFL hydro = 0.011174403474705878 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011174403474705878 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6474e+04 |  512 |      1 | 3.108e-02 | 0.0% |   1.5% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1295.0193573822082 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.880803617012585, dt = 0.011174403474705878 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 1649.00 ns (0.5%)
   gen split merge   : 1116.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 925.00 ns  (0.3%)
   LB compute        : 294.87 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1823.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.667708939695478e-17,-7.082420587500859e-17,-5.4236400526958e-18)
    sum a = (-7.265672438694359e-17,-1.697099492187215e-16,-3.228716122585795e-17)
    sum e = 2.5920015532418508
    sum de = -5.082197683525802e-20
Info: CFL hydro = 0.01116910661872382 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01116910661872382 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9438e+04 |  512 |      1 | 2.634e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.2817341302537 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.89197802048729, dt = 0.01116910661872382 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.49 us    (1.5%)
   patch tree reduce : 1445.00 ns (0.5%)
   gen split merge   : 781.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 938.00 ns  (0.3%)
   LB compute        : 286.32 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.74 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5740338719927305e-17,-7.36286032143596e-17,-5.973249238983014e-18)
    sum a = (5.4858461523421555e-17,-4.732347326508179e-17,-3.057320022148424e-17)
    sum e = 2.5920015521649984
    sum de = -1.4331797467542762e-18
Info: CFL hydro = 0.011164151592237367 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011164151592237367 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9471e+04 |  512 |      1 | 2.629e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.1497163630795 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.903147127106013, dt = 0.011164151592237367 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.4%)
   patch tree reduce : 1446.00 ns (0.5%)
   gen split merge   : 732.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 941.00 ns  (0.3%)
   LB compute        : 289.43 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6993242750451552e-17,-7.342368900375983e-17,-6.247687913893407e-18)
    sum a = (1.3841662191427239e-16,4.731761857335037e-17,-1.0881530052020416e-16)
    sum e = 2.592001550736095
    sum de = -1.2434443665693129e-18
Info: CFL hydro = 0.01115962295847891 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115962295847891 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9591e+04 |  512 |      1 | 2.613e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.8387133293318 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.91431127869825, dt = 0.01115962295847891 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.5%)
   patch tree reduce : 1545.00 ns (0.5%)
   gen split merge   : 765.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 986.00 ns  (0.3%)
   LB compute        : 274.86 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1993.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.899261997673207e-17,-7.245181017634383e-17,-7.783812656925181e-18)
    sum a = (-1.0977546996415732e-16,-1.79171131056699e-16,-8.598785745939085e-17)
    sum e = 2.592001549093547
    sum de = 2.371692252312041e-18
Info: CFL hydro = 0.01115559932300646 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115559932300646 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8966e+04 |  512 |      1 | 2.700e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1488.166338675373 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.92547090165673, dt = 0.01115559932300646 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.6%)
   patch tree reduce : 1611.00 ns (0.5%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 965.00 ns  (0.3%)
   LB compute        : 276.99 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6249696900560996e-17,-7.560163432784872e-17,-8.623229083917772e-18)
    sum a = (-6.172016023264782e-17,-6.407960100041077e-17,9.183083980734974e-17)
    sum e = 2.592001547390575
    sum de = -9.986518448128201e-19
Info: CFL hydro = 0.011152152430034193 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011152152430034193 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9515e+04 |  512 |      1 | 2.624e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1530.6878289078584 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.936626500979738, dt = 0.011152152430034193 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.83 us    (1.2%)
   patch tree reduce : 1145.00 ns (0.4%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 796.00 ns  (0.3%)
   LB compute        : 297.75 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 2.54 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1924.00 ns (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5778394216181546e-17,-7.573043754594e-17,-6.524688016436298e-18)
    sum a = (7.519766059838062e-17,-4.1143846142566166e-17,-3.15860618910202e-17)
    sum e = 2.592001545781695
    sum de = -6.124048208648591e-19
Info: CFL hydro = 0.011149345694549522 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011149345694549522 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9611e+04 |  512 |      1 | 2.611e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.744327305922 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 20.947778653409774, dt = 0.011149345694549522 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.4%)
   patch tree reduce : 1058.00 ns (0.4%)
   gen split merge   : 722.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 863.00 ns  (0.3%)
   LB compute        : 272.17 us  (91.0%)
   LB move op cnt    : 0
   LB apply          : 2.55 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1953.00 ns (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7461618088965292e-17,-7.625150511003653e-17,-7.651350256501766e-18)
    sum a = (-2.8805083318594883e-18,1.5514933088267569e-18,-1.901603874365776e-17)
    sum e = 2.5920015444112696
    sum de = -5.846644918422808e-19
Info: CFL hydro = 0.01114722255994632 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114722255994632 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9535e+04 |  512 |      1 | 2.621e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.4306042042213 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.958927999104322, dt = 0.01114722255994632 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.25 us    (1.8%)
   patch tree reduce : 1250.00 ns (0.4%)
   gen split merge   : 955.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 889.00 ns  (0.3%)
   LB compute        : 274.93 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.70 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1888.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.498046875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.698153336698871e-17,-7.587680483922555e-17,-7.783080820458754e-18)
    sum a = (-5.525658056115823e-17,-9.625698675630456e-17,7.30080058908289e-17)
    sum e = 2.5920015434031964
    sum de = -9.825582188149884e-20
Info: CFL hydro = 0.011140838207109916 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011140838207109916 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9579e+04 |  512 |      1 | 2.615e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1534.5979246793797 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.970075221664267, dt = 0.011140838207109916 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1327.00 ns (0.4%)
   gen split merge   : 706.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1261.00 ns (0.4%)
   LB compute        : 288.37 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6074056148618344e-17,-7.736389653900666e-17,-6.5971398266126415e-18)
    sum a = (-2.0812258166857943e-16,2.4741927256988206e-17,4.218305392489352e-17)
    sum e = 2.592001542817341
    sum de = 3.714239473710107e-19
Info: CFL hydro = 0.01113433928016308 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01113433928016308 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9903e+04 |  512 |      1 | 2.572e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1559.0904647043715 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.981216059871375, dt = 0.01113433928016308 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.4%)
   patch tree reduce : 1660.00 ns (0.5%)
   gen split merge   : 747.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 851.00 ns  (0.3%)
   LB compute        : 296.77 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3032543794144757e-17,-7.639787240332207e-17,-6.280986473115868e-18)
    sum a = (-1.3658995809406881e-16,-4.385164106834871e-18,1.7871446510164813e-17)
    sum e = 2.592001542736551
    sum de = 8.571973426213519e-19
Info: CFL hydro = 0.01112914126513189 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01112914126513189 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9609e+04 |  512 |      1 | 2.611e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1535.1812138596524 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 20.992350399151537, dt = 0.007649600848463223 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.75 us    (1.6%)
   patch tree reduce : 967.00 ns  (0.3%)
   gen split merge   : 679.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 966.00 ns  (0.3%)
   LB compute        : 280.32 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1923.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.232705344050844e-17,-7.66496241477732e-17,-6.2901344289462146e-18)
    sum a = (-1.3758525568841051e-16,-6.47645999329871e-17,-3.493494556139343e-17)
    sum e = 2.5920015237599627
    sum de = 5.039846036163087e-19
Info: CFL hydro = 0.011126693738569905 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011126693738569905 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9474e+04 |  512 |      1 | 2.629e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1047.4088307206814 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 2248                                                    [SPH][rank=0]
Info: time since start : 1819.9815862310002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14991494578008352 max=0.1500824399778859 delta=0.00016749419780237584
Number of particle pairs: 130816
Distance min=0.126707 max=1.845631 mean=0.800519
---------------- t = 21, dt = 0.011126693738569905 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 10.68 us   (1.5%)
   patch tree reduce : 1358.00 ns (0.2%)
   gen split merge   : 495.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 910.00 ns  (0.1%)
   LB compute        : 700.75 us  (96.2%)
   LB move op cnt    : 0
   LB apply          : 6.61 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.26 us    (77.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.066432098878467e-17,-7.77503061932805e-17,-7.00587049311252e-18)
    sum a = (-1.8826346731559695e-16,-1.1420747160484356e-16,3.42001817491e-17)
    sum e = 2.5920015434392933
    sum de = -9.317362419797304e-19
Info: CFL hydro = 0.011123428942694755 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011123428942694755 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7113e+04 |  512 |      1 | 2.992e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1338.8580633697752 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.01112669373857, dt = 0.011123428942694755 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1316.00 ns (0.4%)
   gen split merge   : 733.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 976.00 ns  (0.3%)
   LB compute        : 281.48 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.398555288724462e-18,-7.921983381786734e-17,-6.244394649794482e-18)
    sum a = (-1.4418934796145422e-16,-1.319471875510514e-16,-8.464713305289528e-17)
    sum e = 2.592001544834946
    sum de = 5.251604272976662e-19
Info: CFL hydro = 0.011121719010507824 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011121719010507824 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8830e+04 |  512 |      1 | 2.719e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1472.7157946896891 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.022250122681267, dt = 0.011121719010507824 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.4%)
   patch tree reduce : 1311.00 ns (0.4%)
   gen split merge   : 646.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 914.00 ns  (0.3%)
   LB compute        : 289.71 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.059294555161744e-18,-8.06366692168714e-17,-7.711726764982052e-18)
    sum a = (-9.485771543249477e-17,1.3699978651526834e-17,7.142723912334503e-18)
    sum e = 2.592001546443962
    sum de = -1.4145450219146816e-18
Info: CFL hydro = 0.011121072496710533 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011121072496710533 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8803e+04 |  512 |      1 | 2.723e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1470.3987854128432 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.033371841691775, dt = 0.011121072496710533 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.80 us    (1.5%)
   patch tree reduce : 1466.00 ns (0.5%)
   gen split merge   : 667.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1489.00 ns (0.5%)
   LB compute        : 299.47 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.48 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1905.00 ns (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.058142269088629e-18,-7.977017484062099e-17,-7.137235138836295e-18)
    sum a = (-1.157238367632818e-16,-8.641524995578464e-17,-7.363153056022531e-17)
    sum e = 2.592001548297621
    sum de = 1.1231656880592022e-18
Info: CFL hydro = 0.011121711087243283 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011121711087243283 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8901e+04 |  512 |      1 | 2.709e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1477.9344531120719 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.044492914188485, dt = 0.011121711087243283 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.36 us    (1.7%)
   patch tree reduce : 1344.00 ns (0.4%)
   gen split merge   : 1035.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1032.00 ns (0.3%)
   LB compute        : 293.20 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.49 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.6603346182116925e-18,-8.130703142011919e-17,-8.428377624731392e-18)
    sum a = (-7.161458925875053e-17,-1.483110509403751e-16,2.6870107701360002e-17)
    sum e = 2.5920015502586167
    sum de = -5.963111948670274e-19
Info: CFL hydro = 0.011123597503219822 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011123597503219822 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8672e+04 |  512 |      1 | 2.742e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1460.1135255458062 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.055614625275727, dt = 0.011123597503219822 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.5%)
   patch tree reduce : 1257.00 ns (0.4%)
   gen split merge   : 722.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1368.00 ns (0.4%)
   LB compute        : 290.14 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.224160084220774e-18,-8.318638746590557e-17,-7.580728037491491e-18)
    sum a = (9.170789128098988e-17,-1.2353399553299837e-17,-1.0763850748218839e-17)
    sum e = 2.5920015521807063
    sum de = 3.4220131069073734e-19
Info: CFL hydro = 0.01112667795831344 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01112667795831344 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8901e+04 |  512 |      1 | 2.709e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1478.2887863136891 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.066738222778948, dt = 0.01112667795831344 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 1660.00 ns (0.5%)
   gen split merge   : 649.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1036.00 ns (0.3%)
   LB compute        : 287.46 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.334776453398305e-18,-8.267117459354045e-17,-7.780519392826257e-18)
    sum a = (-1.0396176107485556e-16,-4.598274885858622e-17,-1.3975441897490227e-16)
    sum e = 2.5920015539206744
    sum de = -1.5924219408380846e-19
Info: CFL hydro = 0.011130883392855213 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011130883392855213 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8984e+04 |  512 |      1 | 2.697e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1485.2405537717043 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.07786490073726, dt = 0.011130883392855213 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.4%)
   patch tree reduce : 1604.00 ns (0.5%)
   gen split merge   : 887.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1045.00 ns (0.3%)
   LB compute        : 295.69 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.42 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.36 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.1480490917122915e-18,-8.34088657516996e-17,-1.0145677632983179e-17)
    sum a = (8.927819421244987e-17,-5.8265892111109e-17,7.578898446325422e-18)
    sum e = 2.5920015553488907
    sum de = -1.060485249962384e-18
Info: CFL hydro = 0.011136130795718275 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011136130795718275 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9616e+04 |  512 |      1 | 2.610e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1535.255909096783 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.088995784130116, dt = 0.011136130795718275 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.72 us    (1.4%)
   patch tree reduce : 1308.00 ns (0.4%)
   gen split merge   : 874.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1046.00 ns (0.3%)
   LB compute        : 308.17 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.41 us    (70.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.084488381880027e-18,-8.406166387975311e-17,-9.224524220646444e-18)
    sum a = (1.0995111071609997e-17,8.626302797076768e-17,2.74350854534422e-17)
    sum e = 2.5920015563593815
    sum de = -2.676624113323589e-19
Info: CFL hydro = 0.01114232565925204 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114232565925204 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9154e+04 |  512 |      1 | 2.673e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1499.7985942989794 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.100131914925836, dt = 0.01114232565925204 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (1.5%)
   patch tree reduce : 1313.00 ns (0.4%)
   gen split merge   : 767.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1196.00 ns (0.4%)
   LB compute        : 290.34 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.72 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.848105203223875e-18,-8.231111105205802e-17,-8.741231996656847e-18)
    sum a = (4.605300515936328e-17,1.090963257233124e-16,-7.312509972545733e-18)
    sum e = 2.5920015568778765
    sum de = -4.0657581468206416e-19
Info: CFL hydro = 0.011149362233586691 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011149362233586691 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8985e+04 |  512 |      1 | 2.697e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1487.3395391747604 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.11127424058509, dt = 0.011149362233586691 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.45 us    (1.4%)
   patch tree reduce : 1345.00 ns (0.4%)
   gen split merge   : 706.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 922.00 ns  (0.3%)
   LB compute        : 305.86 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.70 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1922.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.410887445906788e-18,-8.08796389237254e-17,-9.014807333235752e-18)
    sum a = (6.16381945484079e-17,-5.95890524424103e-17,8.733150921175214e-17)
    sum e = 2.592001556868366
    sum de = -2.8697476252975695e-18
Info: CFL hydro = 0.01115712523967673 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115712523967673 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8963e+04 |  512 |      1 | 2.700e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1486.5941846068954 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.122423602818674, dt = 0.01115712523967673 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.6%)
   patch tree reduce : 1383.00 ns (0.5%)
   gen split merge   : 809.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1141.00 ns (0.4%)
   LB compute        : 278.02 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1978.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.336660575937848e-18,-8.273264885672038e-17,-7.515640331758576e-18)
    sum a = (9.426913595437028e-17,2.000548164626803e-17,-4.6814115084448104e-17)
    sum e = 2.59200155633637
    sum de = 7.453889935837843e-20
Info: CFL hydro = 0.011165491748926023 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011165491748926023 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8810e+04 |  512 |      1 | 2.722e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1475.6417022496191 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.13358072805835, dt = 0.011165491748926023 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.3%)
   patch tree reduce : 1197.00 ns (0.4%)
   gen split merge   : 857.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 988.00 ns  (0.3%)
   LB compute        : 302.31 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.538336053812157e-18,-8.197739362336697e-17,-8.838754923280733e-18)
    sum a = (9.005760004919538e-17,-1.4103952380994934e-17,-5.584936809896468e-17)
    sum e = 2.5920015553273954
    sum de = -4.0996394647108136e-19
Info: CFL hydro = 0.011168611806245317 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011168611806245317 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9238e+04 |  512 |      1 | 2.661e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.2940298119706 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.144746219807278, dt = 0.011168611806245317 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.3%)
   patch tree reduce : 1451.00 ns (0.5%)
   gen split merge   : 713.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 859.00 ns  (0.3%)
   LB compute        : 305.52 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.600230766598771e-18,-8.239014939043221e-17,-9.45706525785385e-18)
    sum a = (-2.204291436880279e-18,-1.4525490185657296e-17,8.619862636172204e-17)
    sum e = 2.5920015538808663
    sum de = 2.574980159653073e-19
Info: CFL hydro = 0.011165166449617885 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011165166449617885 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9339e+04 |  512 |      1 | 2.648e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.6736757170956 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.155914831613522, dt = 0.011165166449617885 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.4%)
   patch tree reduce : 1164.00 ns (0.4%)
   gen split merge   : 750.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1731.00 ns (0.6%)
   LB compute        : 279.37 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (63.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.127464409286467e-18,-8.2685811322869e-17,-7.6654381084805e-18)
    sum a = (3.012238895816477e-17,-1.0215266132984624e-16,-1.3171592722766023e-17)
    sum e = 2.5920015521091746
    sum de = 1.4535085374883794e-18
Info: CFL hydro = 0.011162104803581551 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011162104803581551 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8763e+04 |  512 |      1 | 2.729e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1472.9534617783686 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.16707999806314, dt = 0.011162104803581551 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.4%)
   patch tree reduce : 1320.00 ns (0.4%)
   gen split merge   : 991.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 306.54 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.551197723348115e-18,-8.4164120985053e-17,-8.275240844131393e-18)
    sum a = (-1.1943571132100316e-16,1.5427112712296242e-17,7.867242014097941e-19)
    sum e = 2.592001550209813
    sum de = -9.24959978401696e-19
Info: CFL hydro = 0.011159468722097717 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011159468722097717 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9245e+04 |  512 |      1 | 2.660e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.416237975813 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.178242102866722, dt = 0.011159468722097717 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 1542.00 ns (0.5%)
   gen split merge   : 715.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 944.00 ns  (0.3%)
   LB compute        : 272.60 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1859.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.453022574099855e-18,-8.331811802986256e-17,-8.08112122141144e-18)
    sum a = (1.3174227334045163e-16,4.3782848440504505e-17,-7.990410091397726e-17)
    sum e = 2.5920015483341956
    sum de = -2.2971533529536625e-18
Info: CFL hydro = 0.011157293401804881 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011157293401804881 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9543e+04 |  512 |      1 | 2.620e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.4350404432125 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.18940157158882, dt = 0.011157293401804881 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.4%)
   patch tree reduce : 1125.00 ns (0.4%)
   gen split merge   : 568.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1601.00 ns (0.5%)
   LB compute        : 297.91 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.65 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.835882108788496e-18,-8.279997781163172e-17,-9.575348326740229e-18)
    sum a = (9.293737654458845e-17,8.03646090104769e-17,-1.3354131033404757e-16)
    sum e = 2.5920015466332136
    sum de = 1.782157321023048e-18
Info: CFL hydro = 0.01115560752448807 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115560752448807 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9650e+04 |  512 |      1 | 2.606e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1541.5621654599083 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.200558864990626, dt = 0.01115560752448807 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.5%)
   patch tree reduce : 1228.00 ns (0.4%)
   gen split merge   : 650.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 275.15 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1936.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1025848203199961e-17,-8.16846590367959e-17,-1.1274855560901992e-17)
    sum a = (3.1808540176814227e-17,6.994746578822819e-17,-1.1841114026800437e-18)
    sum e = 2.5920015452451888
    sum de = 1.5924219408380846e-18
Info: CFL hydro = 0.01115443082835412 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115443082835412 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9284e+04 |  512 |      1 | 2.655e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1512.611930337956 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.211714472515112, dt = 0.01115443082835412 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1586.00 ns (0.6%)
   gen split merge   : 809.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1020.00 ns (0.4%)
   LB compute        : 271.91 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0851671124190165e-17,-8.082987404400832e-17,-1.056186388348479e-17)
    sum a = (1.6328735238935187e-16,1.9990844916939477e-17,2.3931052452186294e-18)
    sum e = 2.592001544285608
    sum de = 1.1418004128987969e-18
Info: CFL hydro = 0.011153775712211215 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011153775712211215 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9528e+04 |  512 |      1 | 2.622e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.5444918899605 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.222868903343468, dt = 0.011153775712211215 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1107.00 ns (0.4%)
   gen split merge   : 592.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1010.00 ns (0.3%)
   LB compute        : 294.25 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3219893929550253e-17,-8.104357029220521e-17,-1.056003429231872e-17)
    sum a = (3.951331449536521e-17,-1.504070305802241e-17,1.0764289850098696e-16)
    sum e = 2.5920015438384953
    sum de = 1.6059744679941534e-18
Info: CFL hydro = 0.011153644575117054 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011153644575117054 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8922e+04 |  512 |      1 | 2.706e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1483.9588629435245 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.23402267905568, dt = 0.011153644575117054 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1495.00 ns (0.5%)
   gen split merge   : 632.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1038.00 ns (0.3%)
   LB compute        : 285.19 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1930.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2880321809127792e-17,-8.134508691637343e-17,-8.825764826001642e-18)
    sum a = (-1.546692461606991e-16,2.2747233784092823e-16,7.402233123329771e-17)
    sum e = 2.592001543950273
    sum de = -5.8106460181645e-19
Info: CFL hydro = 0.011153732785528989 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011153732785528989 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9226e+04 |  512 |      1 | 2.663e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1507.793804602683 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.245176323630798, dt = 0.011153732785528989 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1012.00 ns (0.3%)
   gen split merge   : 798.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 999.00 ns  (0.3%)
   LB compute        : 299.93 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0321821522496499e-17,-7.741658876458946e-17,-8.071149949556364e-18)
    sum a = (2.5093208760873508e-17,7.991654213390653e-17,-1.5848650516958606e-17)
    sum e = 2.592001544624872
    sum de = 3.3881317890172014e-21
Info: CFL hydro = 0.011153683332492781 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011153683332492781 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9679e+04 |  512 |      1 | 2.602e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1543.2891685982788 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.256330056416328, dt = 0.011153683332492781 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.4%)
   patch tree reduce : 1095.00 ns (0.4%)
   gen split merge   : 768.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1001.00 ns (0.3%)
   LB compute        : 285.71 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1927470729838907e-17,-7.723802066678109e-17,-8.803992691125417e-18)
    sum a = (4.706586682889924e-17,1.75172376604138e-17,-2.9940893514490697e-17)
    sum e = 2.592001545824295
    sum de = 4.9636130709102e-19
Info: CFL hydro = 0.011154152174547417 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011154152174547417 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8715e+04 |  512 |      1 | 2.736e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1467.725204676177 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.26748373974882, dt = 0.011154152174547417 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.5%)
   patch tree reduce : 1408.00 ns (0.5%)
   gen split merge   : 665.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 965.00 ns  (0.3%)
   LB compute        : 279.11 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2000.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2114820865244401e-17,-7.750148179469508e-17,-9.267016475478403e-18)
    sum a = (1.7306468758082615e-17,3.887515309664025e-18,-6.528566749708364e-17)
    sum e = 2.5920015474779787
    sum de = -1.7618285302889447e-19
Info: CFL hydro = 0.01115512760630969 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115512760630969 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8492e+04 |  512 |      1 | 2.769e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1450.2515516455167 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.278637891923367, dt = 0.01115512760630969 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.5%)
   patch tree reduce : 1312.00 ns (0.4%)
   gen split merge   : 966.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1044.00 ns (0.3%)
   LB compute        : 288.05 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (14.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2177758801357185e-17,-7.757759278720356e-17,-1.0168867701013107e-17)
    sum a = (-3.464221097482234e-17,2.693158196453993e-18,-8.084743811920259e-17)
    sum e = 2.5920015494791335
    sum de = -8.682087709356578e-19
Info: CFL hydro = 0.011156590460911485 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011156590460911485 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9223e+04 |  512 |      1 | 2.664e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1507.727564754423 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.289793019529675, dt = 0.011156590460911485 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.5%)
   patch tree reduce : 2.07 us    (0.7%)
   gen split merge   : 799.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1008.00 ns (0.3%)
   LB compute        : 276.82 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.43 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1954.00 ns (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1573261880087893e-17,-7.750148179469508e-17,-1.1207252167315732e-17)
    sum a = (-2.848892996509811e-17,-1.3479842242425378e-16,3.226227878599941e-17)
    sum e = 2.592001551696133
    sum de = -5.620063605032283e-19
Info: CFL hydro = 0.01115851409512306 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115851409512306 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9417e+04 |  512 |      1 | 2.637e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.1417823687416 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.300949609990585, dt = 0.01115851409512306 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.6%)
   patch tree reduce : 1381.00 ns (0.5%)
   gen split merge   : 1115.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 982.00 ns  (0.3%)
   LB compute        : 274.09 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0927782116698647e-17,-7.990483275044368e-17,-9.963587572180132e-18)
    sum a = (-2.03368571982665e-16,-1.1603999011677857e-17,-6.50046422939754e-17)
    sum e = 2.592001553982794
    sum de = -7.805408608948378e-19
Info: CFL hydro = 0.01116086495793332 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01116086495793332 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9190e+04 |  512 |      1 | 2.668e-02 | 0.0% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1505.6140181092414 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.312108124085707, dt = 0.01116086495793332 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1251.00 ns (0.4%)
   gen split merge   : 778.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1002.00 ns (0.3%)
   LB compute        : 288.99 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.10142968335481e-18,-7.93427823442272e-17,-1.1512336494257786e-17)
    sum a = (-3.553797880972986e-18,4.250506197012172e-18,8.692460813641833e-17)
    sum e = 2.592001556189388
    sum de = 5.245251525872255e-19
Info: CFL hydro = 0.011157796125002022 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011157796125002022 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9468e+04 |  512 |      1 | 2.630e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.762054464738 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.32326898904364, dt = 0.011157796125002022 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 14.50 us   (4.6%)
   gen split merge   : 1096.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 918.00 ns  (0.3%)
   LB compute        : 287.64 us  (90.4%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.58 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.875712664835334e-18,-7.897979145687906e-17,-9.629138307022667e-18)
    sum a = (7.429603807174167e-18,-5.220043147735609e-17,1.8910654292492167e-17)
    sum e = 2.5920015581286187
    sum de = 1.0191923937837369e-18
Info: CFL hydro = 0.011152141668517458 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011152141668517458 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9655e+04 |  512 |      1 | 2.605e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.0289159892864 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.33442678516864, dt = 0.011152141668517458 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.83 us    (1.7%)
   patch tree reduce : 1573.00 ns (0.5%)
   gen split merge   : 823.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 982.00 ns  (0.3%)
   LB compute        : 273.63 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.314814544691963e-18,-8.003070862266926e-17,-9.871742095643454e-18)
    sum a = (-1.0791953268529663e-16,-2.8805083318594883e-18,1.795165578688529e-16)
    sum e = 2.592001559694104
    sum de = -9.571472303973594e-20
Info: CFL hydro = 0.011146907311133911 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011146907311133911 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9165e+04 |  512 |      1 | 2.672e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1502.7562085960628 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.34557892683716, dt = 0.011146907311133911 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.5%)
   patch tree reduce : 1430.00 ns (0.5%)
   gen split merge   : 716.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 927.00 ns  (0.3%)
   LB compute        : 282.25 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.435458498905589e-18,-7.986970460005516e-17,-6.894997268448721e-18)
    sum a = (9.454448942486371e-17,-8.224670944301238e-17,-1.2218156174303995e-16)
    sum e = 2.592001560815088
    sum de = -4.582448244645765e-19
Info: CFL hydro = 0.01114219232102453 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01114219232102453 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9660e+04 |  512 |      1 | 2.604e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1540.9154886342303 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.356725834148293, dt = 0.01114219232102453 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.3%)
   patch tree reduce : 1641.00 ns (0.5%)
   gen split merge   : 685.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 997.00 ns  (0.3%)
   LB compute        : 338.54 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.32 us    (69.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.595839747800206e-18,-8.125726654040211e-17,-9.98041981090797e-18)
    sum a = (-1.7268413261828374e-17,1.853361214498861e-16,-6.768023641523513e-17)
    sum e = 2.5920015614350196
    sum de = 3.3796614595446584e-19
Info: CFL hydro = 0.011138089699270616 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011138089699270616 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9143e+04 |  512 |      1 | 2.675e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1499.7246094016111 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.367868026469317, dt = 0.011138089699270616 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1219.00 ns (0.4%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 996.00 ns  (0.3%)
   LB compute        : 284.19 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1947.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.913768161089575e-18,-7.746342629844083e-17,-1.0497096356205937e-17)
    sum a = (1.6345274743076453e-16,1.1334097722859315e-16,1.5725116521425608e-16)
    sum e = 2.5920015615347913
    sum de = -9.850993176567513e-19
Info: CFL hydro = 0.011134685413973576 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011134685413973576 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9694e+04 |  512 |      1 | 2.600e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.3274212710064 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.379006116168586, dt = 0.011134685413973576 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.5%)
   patch tree reduce : 1141.00 ns (0.4%)
   gen split merge   : 741.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 971.00 ns  (0.3%)
   LB compute        : 276.41 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.66 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.168303735005205e-17,-7.672573514028169e-17,-7.371788726326378e-18)
    sum a = (-2.956838875307899e-17,6.937224232561601e-17,4.385164106834871e-18)
    sum e = 2.5920015611358402
    sum de = -3.6591823321385775e-19
Info: CFL hydro = 0.011132060487761435 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011132060487761435 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9153e+04 |  512 |      1 | 2.673e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1499.536838181236 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.39014080158256, dt = 0.011132060487761435 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.5%)
   patch tree reduce : 1282.00 ns (0.4%)
   gen split merge   : 693.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1014.00 ns (0.3%)
   LB compute        : 277.73 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.38 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0269129296913703e-17,-7.63510348694707e-17,-8.2807296176296e-18)
    sum a = (1.1708175932673843e-16,-9.767967684704005e-17,6.305502994741197e-17)
    sum e = 2.592001560297573
    sum de = -4.1081097941833566e-19
Info: CFL hydro = 0.011130277768313187 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011130277768313187 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9192e+04 |  512 |      1 | 2.668e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1502.228194684689 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.40127286207032, dt = 0.011130277768313187 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.5%)
   patch tree reduce : 1451.00 ns (0.5%)
   gen split merge   : 679.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 913.00 ns  (0.3%)
   LB compute        : 275.83 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.40 us    (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2198250222417162e-17,-7.849385204317105e-17,-7.25908591049651e-18)
    sum a = (2.6696662458816633e-17,6.270960313525809e-17,-1.114147836489554e-17)
    sum e = 2.5920015591089576
    sum de = 9.232659125071874e-19
Info: CFL hydro = 0.011129389683479866 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011129389683479866 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9540e+04 |  512 |      1 | 2.620e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.1999163719142 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.412403139838634, dt = 0.011129389683479866 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.10 us    (1.6%)
   patch tree reduce : 1631.00 ns (0.5%)
   gen split merge   : 857.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 981.00 ns  (0.3%)
   LB compute        : 301.22 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2183613493088607e-17,-7.682526489971586e-17,-7.776494292260904e-18)
    sum a = (-1.1941229255407748e-16,5.1462740319196955e-18,5.047329741658668e-17)
    sum e = 2.592001557684952
    sum de = 2.558039500707987e-19
Info: CFL hydro = 0.011129436061026805 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011129436061026805 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9462e+04 |  512 |      1 | 2.631e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1522.969016612688 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.423532529522113, dt = 0.011129436061026805 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1381.00 ns (0.5%)
   gen split merge   : 751.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1014.00 ns (0.3%)
   LB compute        : 283.16 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.903211063699845e-18,-7.710043541109268e-17,-6.813397502442031e-18)
    sum a = (-6.140400687915104e-17,-1.4626483618024323e-16,-1.3982760262154503e-16)
    sum e = 2.592001556155429
    sum de = 7.453889935837843e-19
Info: CFL hydro = 0.011130444253767816 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011130444253767816 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9507e+04 |  512 |      1 | 2.625e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1526.4739115558268 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.43466196558314, dt = 0.011130444253767816 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1549.00 ns (0.5%)
   gen split merge   : 831.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 967.00 ns  (0.3%)
   LB compute        : 295.15 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.821245379459941e-18,-7.960624347214117e-17,-9.521192428224578e-18)
    sum a = (-1.17726141335428e-16,1.867910123451444e-16,-1.9712454325110374e-16)
    sum e = 2.5920015546552744
    sum de = 4.946672411965114e-19
Info: CFL hydro = 0.011132429701889946 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011132429701889946 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9661e+04 |  512 |      1 | 2.604e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1538.6687534286941 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.44579240983691, dt = 0.011132429701889946 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.36 us    (1.5%)
   patch tree reduce : 1598.00 ns (0.5%)
   gen split merge   : 1009.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 885.00 ns  (0.3%)
   LB compute        : 281.93 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.72 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.906761183285037e-18,-7.573629223767142e-17,-1.2037978036269492e-17)
    sum a = (7.471464853053833e-17,3.395062551404815e-17,-8.385967701501906e-17)
    sum e = 2.592001553313931
    sum de = 5.47183283926278e-19
Info: CFL hydro = 0.011135392927848674 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011135392927848674 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9744e+04 |  512 |      1 | 2.593e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1545.483671796683 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.456924839538797, dt = 0.011135392927848674 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.6%)
   patch tree reduce : 1662.00 ns (0.6%)
   gen split merge   : 773.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1051.00 ns (0.4%)
   LB compute        : 279.81 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0266201951047992e-17,-7.601146274904824e-17,-1.2280215906657066e-17)
    sum a = (3.129918199618053e-17,1.6822139384600755e-16,-4.314907806057811e-17)
    sum e = 2.5920015522477247
    sum de = -1.2485265642528387e-18
Info: CFL hydro = 0.011139320287004364 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011139320287004364 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0095e+04 |  512 |      1 | 2.548e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1573.375935633479 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.468060232466645, dt = 0.011139320287004364 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1245.00 ns (0.4%)
   gen split merge   : 652.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 290.30 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1986.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0214973398398052e-17,-7.358762037223965e-17,-1.2512208066514651e-17)
    sum a = (1.0296939082637957e-16,9.581349385764936e-17,8.097038664556244e-18)
    sum e = 2.5920015515487904
    sum de = -2.913793338554793e-19
Info: CFL hydro = 0.011144184088648418 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011144184088648418 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9968e+04 |  512 |      1 | 2.564e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1563.9539590259815 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.47919955275365, dt = 0.011144184088648418 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.6%)
   patch tree reduce : 1321.00 ns (0.5%)
   gen split merge   : 771.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1043.00 ns (0.4%)
   LB compute        : 267.73 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.462890625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1624490432737833e-17,-7.297873243217179e-17,-1.2155071870897926e-17)
    sum a = (8.685727918150698e-17,-4.0426646405467e-18,2.262838354194496e-18)
    sum e = 2.592001551278932
    sum de = 9.910285482875314e-19
Info: CFL hydro = 0.011148617111414658 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011148617111414658 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9683e+04 |  512 |      1 | 2.601e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.3214401810687 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.4903437368423, dt = 0.009656263157701517 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.5%)
   patch tree reduce : 1712.00 ns (0.6%)
   gen split merge   : 807.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1019.00 ns (0.4%)
   LB compute        : 265.90 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.58 us    (1.3%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.462890625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2644670466938068e-17,-7.358762037223965e-17,-1.206066496672875e-17)
    sum a = (-2.1188129376015218e-17,1.8556445442741153e-17,4.5559747380991e-17)
    sum e = 2.592001542681669
    sum de = 1.2536087619363645e-18
Info: CFL hydro = 0.01115307015262592 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115307015262592 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9563e+04 |  512 |      1 | 2.617e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1328.2674634971183 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 2293                                                    [SPH][rank=0]
Info: time since start : 1821.972487917 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.1499127984807479 max=0.15008978933376793 delta=0.00017699085302003148
Number of particle pairs: 130816
Distance min=0.128862 max=1.843448 mean=0.800578
---------------- t = 21.5, dt = 0.01115307015262592 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.15 us    (1.8%)
   patch tree reduce : 1361.00 ns (0.3%)
   gen split merge   : 700.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 768.00 ns  (0.2%)
   LB compute        : 483.36 us  (95.6%)
   LB move op cnt    : 0
   LB apply          : 3.80 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.61 us    (73.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1808913222277616e-17,-7.316608256757728e-17,-1.1331024009700319e-17)
    sum a = (8.871028911450196e-17,-9.420198995857553e-18,1.927510885277317e-17)
    sum e = 2.5920015518235955
    sum de = 5.082197683525802e-20
Info: CFL hydro = 0.011154766175607086 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011154766175607086 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7213e+04 |  512 |      1 | 2.975e-02 | 0.1% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1349.8356319648199 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.511153070152627, dt = 0.011154766175607086 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.21 us    (1.7%)
   patch tree reduce : 1295.00 ns (0.4%)
   gen split merge   : 690.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1309.00 ns (0.4%)
   LB compute        : 288.31 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (64.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3354551839372951e-17,-7.337685146990847e-17,-1.1302482387509638e-17)
    sum a = (8.945968965612394e-17,-3.4249946628817085e-18,-7.805035914451585e-18)
    sum e = 2.592001552826465
    sum de = -5.827586677109586e-19
Info: CFL hydro = 0.011149174860857206 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011149174860857206 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9800e+04 |  512 |      1 | 2.586e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1552.9183640868057 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.522307836328235, dt = 0.011149174860857206 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.86 us    (1.2%)
   patch tree reduce : 1422.00 ns (0.5%)
   gen split merge   : 800.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 869.00 ns  (0.3%)
   LB compute        : 297.85 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.82 us    (70.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4452306539014526e-17,-7.320121071796582e-17,-1.167059613012278e-17)
    sum a = (1.4346922087848934e-17,-1.1984553974220269e-17,-6.643154044439284e-17)
    sum e = 2.592001554048883
    sum de = 2.2378610466458615e-18
Info: CFL hydro = 0.011144438005368613 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011144438005368613 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9463e+04 |  512 |      1 | 2.631e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1525.7551050657808 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.533457011189093, dt = 0.011144438005368613 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.5%)
   patch tree reduce : 1528.00 ns (0.5%)
   gen split merge   : 735.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1041.00 ns (0.3%)
   LB compute        : 281.13 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.78 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1903.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3942948358380835e-17,-7.346467184587979e-17,-1.2739077371107243e-17)
    sum a = (8.539067890278584e-18,-1.0043138196080826e-16,1.5016918372863506e-17)
    sum e = 2.592001555497604
    sum de = -9.605353621863766e-19
Info: CFL hydro = 0.011140621224992988 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011140621224992988 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9779e+04 |  512 |      1 | 2.589e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1549.8628211964879 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.54460144919446, dt = 0.011140621224992988 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1960.00 ns (0.6%)
   gen split merge   : 781.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 999.00 ns  (0.3%)
   LB compute        : 287.19 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4098097689263512e-17,-7.507471207202077e-17,-1.1889415233584666e-17)
    sum a = (4.869347113023448e-17,-3.6427891952905966e-17,-1.3232335149479524e-17)
    sum e = 2.5920015570540063
    sum de = -2.281059726955831e-18
Info: CFL hydro = 0.011137777916380976 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011137777916380976 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9733e+04 |  512 |      1 | 2.595e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1545.742544617887 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.555742070419452, dt = 0.011137777916380976 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.67 us    (1.5%)
   patch tree reduce : 1268.00 ns (0.4%)
   gen split merge   : 682.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1295.00 ns (0.4%)
   LB compute        : 304.39 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.33 us    (71.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.483871619328836e-17,-7.509813083894645e-17,-1.2549531726302465e-17)
    sum a = (-6.301404710529201e-17,1.2557142825553314e-16,-6.626340101623107e-17)
    sum e = 2.5920015585926093
    sum de = 6.115577879176048e-19
Info: CFL hydro = 0.011135947665723005 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011135947665723005 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0254e+04 |  512 |      1 | 2.528e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1586.1103515602915 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.566879848335834, dt = 0.011135947665723005 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.72 us    (1.3%)
   patch tree reduce : 1482.00 ns (0.5%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 947.00 ns  (0.3%)
   LB compute        : 282.00 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.32 us    (69.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3695587632728268e-17,-7.293189489832041e-17,-1.3356747348772235e-17)
    sum a = (1.0101392378808471e-16,7.715312763667547e-17,-1.3911479390324445e-16)
    sum e = 2.5920015599911297
    sum de = 1.7076184216646695e-18
Info: CFL hydro = 0.011135156304827308 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011135156304827308 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0107e+04 |  512 |      1 | 2.546e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1574.3668577050644 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.578015796001555, dt = 0.011135156304827308 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.79 us    (1.7%)
   patch tree reduce : 1309.00 ns (0.5%)
   gen split merge   : 744.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1257.00 ns (0.5%)
   LB compute        : 260.33 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5592507753708905e-17,-7.221762250708697e-17,-1.5382470687844153e-17)
    sum a = (1.1527741651876089e-16,1.3006783150526502e-16,-5.881037844213122e-18)
    sum e = 2.592001561140181
    sum de = 1.6517142471458857e-19
Info: CFL hydro = 0.01113541535879658 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01113541535879658 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0044e+04 |  512 |      1 | 2.554e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1569.2943867558479 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.589150952306383, dt = 0.01113541535879658 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.6%)
   patch tree reduce : 1418.00 ns (0.5%)
   gen split merge   : 723.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1078.00 ns (0.4%)
   LB compute        : 267.34 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1973.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.729915039341834e-17,-7.057245413055745e-17,-1.4734795415055622e-17)
    sum a = (-2.3222634752684268e-17,-8.732858186588643e-17,-1.389552535535632e-16)
    sum e = 2.5920015619523147
    sum de = 9.656175598699024e-20
Info: CFL hydro = 0.011136722029671562 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011136722029671562 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9801e+04 |  512 |      1 | 2.586e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1550.297867670375 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.60028636766518, dt = 0.011136722029671562 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.6%)
   patch tree reduce : 1429.00 ns (0.5%)
   gen split merge   : 1096.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 1005.00 ns (0.4%)
   LB compute        : 262.12 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6249696900560996e-17,-7.275039945464634e-17,-1.7025443554974374e-17)
    sum a = (-1.3402450536100645e-16,-1.8336894502812838e-17,1.1674255312454917e-16)
    sum e = 2.5920015623686403
    sum de = -1.1773757966834775e-18
Info: CFL hydro = 0.011139059787875067 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011139059787875067 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0045e+04 |  512 |      1 | 2.554e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1569.6167411649255 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.611423089694853, dt = 0.011139059787875067 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.6%)
   patch tree reduce : 1310.00 ns (0.5%)
   gen split merge   : 723.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1208.00 ns (0.4%)
   LB compute        : 271.60 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4210800505093378e-17,-7.263916031174932e-17,-1.420421397689553e-17)
    sum a = (4.277840289033247e-17,-1.4921267346701405e-16,1.0166672191613824e-17)
    sum e = 2.592001562364212
    sum de = 5.929230630780102e-19
Info: CFL hydro = 0.011142398412576528 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011142398412576528 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9275e+04 |  512 |      1 | 2.656e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.6662990823756 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.62256214948273, dt = 0.011142398412576528 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.23 us    (1.8%)
   patch tree reduce : 1313.00 ns (0.5%)
   gen split merge   : 669.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1294.00 ns (0.4%)
   LB compute        : 273.81 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5509078396536146e-17,-7.503958392163223e-17,-1.487018516134475e-17)
    sum a = (-5.620064960284999e-17,-1.1861605447860412e-16,-2.513711894885917e-17)
    sum e = 2.5920015619494863
    sum de = -1.3654171109739321e-18
Info: CFL hydro = 0.011146694809293745 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011146694809293745 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0035e+04 |  512 |      1 | 2.555e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1569.6613383708743 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.633704547895306, dt = 0.011146694809293745 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.2%)
   patch tree reduce : 1782.00 ns (0.5%)
   gen split merge   : 722.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1038.00 ns (0.3%)
   LB compute        : 374.99 us  (95.5%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.49 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4449379193148814e-17,-7.61080651626167e-17,-1.531880091526494e-17)
    sum a = (-4.8271933325572116e-17,-1.164263997710524e-16,9.959708838908065e-17)
    sum e = 2.5920015611703935
    sum de = -4.69468011015696e-19
Info: CFL hydro = 0.01115189342018337 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01115189342018337 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9912e+04 |  512 |      1 | 2.571e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1560.6407958072461 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.6448512427046, dt = 0.01115189342018337 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.5%)
   patch tree reduce : 1460.00 ns (0.5%)
   gen split merge   : 747.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 940.00 ns  (0.3%)
   LB compute        : 262.94 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.360191256502552e-17,-7.75366099450836e-17,-1.3419685284885019e-17)
    sum a = (-1.6732708968403286e-16,1.815891187417762e-16,1.677661915638895e-17)
    sum e = 2.5920015601053024
    sum de = 9.273025538964461e-20
Info: CFL hydro = 0.011157929618225908 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011157929618225908 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9775e+04 |  512 |      1 | 2.589e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1550.5967919937955 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.656003136124784, dt = 0.011157929618225908 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1630.00 ns (0.5%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1007.00 ns (0.3%)
   LB compute        : 290.35 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1128305308499842e-17,-7.391255576333355e-17,-1.3827318196685256e-17)
    sum a = (2.565935745130199e-16,2.857089564933801e-17,2.8521130769620926e-17)
    sum e = 2.5920015588592644
    sum de = -1.1154365124155068e-18
Info: CFL hydro = 0.011158688024980868 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011158688024980868 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9976e+04 |  512 |      1 | 2.563e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1567.1974610565733 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.66716106574301, dt = 0.011158688024980868 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.19 us    (1.2%)
   patch tree reduce : 1373.00 ns (0.4%)
   gen split merge   : 854.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 956.00 ns  (0.3%)
   LB compute        : 326.17 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.34 us    (70.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.649413028034785e-17,-7.429018338001026e-17,-1.3467986491669247e-17)
    sum a = (1.5198779734770795e-17,1.355595323493386e-16,6.5777461602523065e-18)
    sum e = 2.5920015575155007
    sum de = -5.141489989833603e-19
Info: CFL hydro = 0.011159338279464446 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011159338279464446 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9546e+04 |  512 |      1 | 2.619e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.5821048656271 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.67831975376799, dt = 0.011159338279464446 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.4%)
   patch tree reduce : 1204.00 ns (0.4%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 965.00 ns  (0.3%)
   LB compute        : 284.54 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1950.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5321728261130653e-17,-7.224396861987836e-17,-1.3244044532942366e-17)
    sum a = (2.6135343889066574e-17,3.559067103531266e-17,-3.2317898357447916e-18)
    sum e = 2.592001556244893
    sum de = -6.822850390133389e-19
Info: CFL hydro = 0.011160251003678866 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011160251003678866 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9603e+04 |  512 |      1 | 2.612e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1538.1635156836244 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.689479092047456, dt = 0.011160251003678866 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.02 us    (1.3%)
   patch tree reduce : 1261.00 ns (0.4%)
   gen split merge   : 648.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 843.00 ns  (0.3%)
   LB compute        : 294.19 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1982.00 ns (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.570960158833734e-17,-7.222347719881839e-17,-1.3414196511386811e-17)
    sum a = (5.970614627703874e-17,-3.8998101623000105e-17,-1.0127153022426726e-16)
    sum e = 2.5920015551805893
    sum de = 1.102836897325099e-18
Info: CFL hydro = 0.011161425110271048 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011161425110271048 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9465e+04 |  512 |      1 | 2.630e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.4453474487023 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.700639343051137, dt = 0.011161425110271048 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.5%)
   patch tree reduce : 1335.00 ns (0.5%)
   gen split merge   : 669.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 993.00 ns  (0.3%)
   LB compute        : 273.97 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.71 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1966.00 ns (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6723926930806155e-17,-7.31192450337259e-17,-1.4937148198022886e-17)
    sum a = (-2.8061537468704323e-17,-2.7054530490899785e-17,-4.435514455725098e-17)
    sum e = 2.5920015544403876
    sum de = -3.849764745270795e-19
Info: CFL hydro = 0.011162856037834045 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011162856037834045 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9426e+04 |  512 |      1 | 2.636e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1524.5014947121535 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.711800768161407, dt = 0.011162856037834045 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.6%)
   patch tree reduce : 1472.00 ns (0.5%)
   gen split merge   : 823.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1177.00 ns (0.4%)
   LB compute        : 278.40 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.63 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.56583730356874e-17,-7.347930857520834e-17,-1.538722762487593e-17)
    sum a = (5.4723803613598854e-17,9.229921514586347e-17,4.816654887440652e-17)
    sum e = 2.5920015541196895
    sum de = -2.464865876510014e-19
Info: CFL hydro = 0.011164535582680926 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011164535582680926 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9701e+04 |  512 |      1 | 2.599e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1546.343248092368 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.72296362419924, dt = 0.011164535582680926 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.08 us    (1.4%)
   patch tree reduce : 1306.00 ns (0.5%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1061.00 ns (0.4%)
   LB compute        : 270.68 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.667416205108907e-17,-7.163215333394479e-17,-1.4230194171453713e-17)
    sum a = (-1.3951730395977967e-17,1.2597832933086694e-16,-4.422341399329399e-17)
    sum e = 2.592001554283673
    sum de = 3.3881317890172014e-21
Info: CFL hydro = 0.011166451941433578 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011166451941433578 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9322e+04 |  512 |      1 | 2.650e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1516.8065029548213 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.73412815978192, dt = 0.011166451941433578 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 1258.00 ns (0.4%)
   gen split merge   : 769.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1016.00 ns (0.3%)
   LB compute        : 274.46 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.69 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1899.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.607112880275263e-17,-7.017726243868649e-17,-1.5179020150177246e-17)
    sum a = (-6.214169803731017e-17,3.5909751734675144e-17,-2.8570895649338013e-18)
    sum e = 2.5920015549616098
    sum de = -4.785736151986797e-19
Info: CFL hydro = 0.011168589551353601 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011168589551353601 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9221e+04 |  512 |      1 | 2.664e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.134021192361 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.745294611723356, dt = 0.011168589551353601 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.72 us    (1.4%)
   patch tree reduce : 1386.00 ns (0.4%)
   gen split merge   : 889.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1002.00 ns (0.3%)
   LB compute        : 324.06 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.47 us    (71.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5342219682190628e-17,-7.0232882010135e-17,-1.5118277723463746e-17)
    sum a = (-1.0878017236981562e-17,1.4269054687821025e-16,-1.2522014675164783e-16)
    sum e = 2.592001556143637
    sum de = 5.89534931288993e-19
Info: CFL hydro = 0.011170929318561635 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011170929318561635 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9238e+04 |  512 |      1 | 2.661e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.7058435040299 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.75646320127471, dt = 0.011170929318561635 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.15 us    (1.4%)
   patch tree reduce : 1669.00 ns (0.6%)
   gen split merge   : 871.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1131.00 ns (0.4%)
   LB compute        : 276.85 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1893.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5667155073284532e-17,-6.821886805452592e-17,-1.7170347175327062e-17)
    sum a = (4.669702124981967e-17,4.563805388289877e-17,3.090399030430957e-17)
    sum e = 2.5920015577811615
    sum de = -1.0511678875425867e-18
Info: CFL hydro = 0.01117344878345071 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01117344878345071 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9158e+04 |  512 |      1 | 2.672e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1504.8150504767054 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.767634130593272, dt = 0.01117344878345071 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.4%)
   patch tree reduce : 1149.00 ns (0.4%)
   gen split merge   : 761.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 883.00 ns  (0.3%)
   LB compute        : 297.94 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (64.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6580486983386322e-17,-6.796711631007479e-17,-1.5928054773566013e-17)
    sum a = (-6.512759082033526e-17,-1.6556263196347565e-16,3.4683193816942294e-17)
    sum e = 2.5920015597892343
    sum de = 7.199780051661553e-20
Info: CFL hydro = 0.011176122483711949 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011176122483711949 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9041e+04 |  512 |      1 | 2.689e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1495.912617218777 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.77880757937672, dt = 0.011176122483711949 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.4%)
   patch tree reduce : 1336.00 ns (0.4%)
   gen split merge   : 751.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 952.00 ns  (0.3%)
   LB compute        : 294.32 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.507875855427665e-17,-7.102912008560836e-17,-1.5539449609892896e-17)
    sum a = (-1.2701168242146287e-16,-9.459864532337936e-17,7.894759065235624e-17)
    sum e = 2.592001562052652
    sum de = 6.013933925505532e-19
Info: CFL hydro = 0.011178922101850949 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011178922101850949 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9320e+04 |  512 |      1 | 2.650e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.2333833107484 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.789983701860432, dt = 0.011178922101850949 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.08 us    (1.7%)
   patch tree reduce : 1400.00 ns (0.5%)
   gen split merge   : 809.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 976.00 ns  (0.3%)
   LB compute        : 272.21 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.96 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3533119937181315e-17,-7.184584958214168e-17,-1.4552202216681908e-17)
    sum a = (-6.62165634823797e-17,-8.972315078403791e-17,-9.957659696802068e-17)
    sum e = 2.592001564433688
    sum de = 1.7110065534536867e-19
Info: CFL hydro = 0.011181816836320553 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011181816836320553 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9392e+04 |  512 |      1 | 2.640e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1524.26278595138 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 21.801162623962284, dt = 0.011181816836320553 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.76 us    (1.6%)
   patch tree reduce : 1192.00 ns (0.4%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 950.00 ns  (0.3%)
   LB compute        : 273.82 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1761.00 ns (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2900813230187769e-17,-7.282065575542341e-17,-1.6534381286001375e-17)
    sum a = (8.022098610394046e-17,1.229485263598562e-18,2.7749775134006115e-17)
    sum e = 2.5920015667822636
    sum de = -8.148456952586369e-19
Info: CFL hydro = 0.011184773825301746 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011184773825301746 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9331e+04 |  512 |      1 | 2.649e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1519.8076601428147 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.812344440798604, dt = 0.011184773825301746 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.5%)
   patch tree reduce : 1269.00 ns (0.4%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 983.00 ns  (0.3%)
   LB compute        : 277.50 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.41 us    (70.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.46074558698972e-17,-7.211516540178708e-17,-1.5665142523001856e-17)
    sum a = (1.7034811061744648e-16,1.241633748941262e-16,-8.755618300694546e-17)
    sum e = 2.592001568947095
    sum de = -1.0757318430129614e-19
Info: CFL hydro = 0.011185077918251464 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011185077918251464 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9484e+04 |  512 |      1 | 2.628e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1532.3138544503124 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.823529214623907, dt = 0.011185077918251464 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.3%)
   patch tree reduce : 1426.00 ns (0.4%)
   gen split merge   : 644.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 912.00 ns  (0.3%)
   LB compute        : 318.37 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.36 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.718352023172276e-17,-7.013335225070083e-17,-1.724664112695215e-17)
    sum a = (-7.40325769438277e-17,-5.264538804894414e-17,-5.856228588001222e-17)
    sum e = 2.592001570765116
    sum de = -2.583450489125616e-19
Info: CFL hydro = 0.011184576322103953 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011184576322103953 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9415e+04 |  512 |      1 | 2.637e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1526.926134569971 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.83471429254216, dt = 0.011184576322103953 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.72 us    (1.5%)
   patch tree reduce : 1706.00 ns (0.5%)
   gen split merge   : 709.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 969.00 ns  (0.3%)
   LB compute        : 297.20 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4616237907494335e-17,-7.192196057465016e-17,-1.7626281293911527e-17)
    sum a = (-3.268674393652748e-17,-2.7599016821922005e-17,8.381320539940091e-17)
    sum e = 2.59200157212869
    sum de = 3.6422416731934915e-19
Info: CFL hydro = 0.011184292855064266 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011184292855064266 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9108e+04 |  512 |      1 | 2.680e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1502.665937668844 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 21.845898868864264, dt = 0.011184292855064266 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.3%)
   patch tree reduce : 1346.00 ns (0.4%)
   gen split merge   : 738.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 918.00 ns  (0.3%)
   LB compute        : 290.38 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4721622358659923e-17,-7.182535816108171e-17,-1.5848467557842e-17)
    sum a = (-1.3233945189705665e-16,-1.646163674123846e-16,7.23979287165031e-17)
    sum e = 2.5920015729562937
    sum de = -1.8766014946419024e-18
Info: CFL hydro = 0.011184198352047797 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011184198352047797 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9550e+04 |  512 |      1 | 2.619e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.3695869256505 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.857083161719327, dt = 0.011184198352047797 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1270.00 ns (0.4%)
   gen split merge   : 709.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 986.00 ns  (0.3%)
   LB compute        : 298.86 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2605151297750972e-17,-7.440727721463868e-17,-1.5375518241413088e-17)
    sum a = (3.4484134298073955e-18,-1.4186503534407979e-16,2.36618281120992e-17)
    sum e = 2.5920015731949437
    sum de = 6.2426328212641935e-19
Info: CFL hydro = 0.01118426269804834 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01118426269804834 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9177e+04 |  512 |      1 | 2.670e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1508.0925066923287 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.868267360071375, dt = 0.01118426269804834 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.39 us    (1.5%)
   patch tree reduce : 1645.00 ns (0.6%)
   gen split merge   : 1161.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 968.00 ns  (0.3%)
   LB compute        : 275.82 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3313568997253e-17,-7.585045872643414e-17,-1.5256411856501978e-17)
    sum a = (3.2054437229533936e-17,-1.3965196186960237e-16,1.4287496966775004e-16)
    sum e = 2.5920015728324173
    sum de = -9.605353621863766e-19
Info: CFL hydro = 0.011184455497042053 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011184455497042053 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9476e+04 |  512 |      1 | 2.629e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.5949354361999 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.879451622769423, dt = 0.011184455497042053 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.5%)
   patch tree reduce : 1236.00 ns (0.4%)
   gen split merge   : 673.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 973.00 ns  (0.3%)
   LB compute        : 276.40 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.39 us    (69.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3881474095200907e-17,-7.738731530593235e-17,-1.2988267687925881e-17)
    sum a = (1.5298309494204965e-17,-1.4493289381134477e-16,3.542088497510143e-17)
    sum e = 2.5920015718984404
    sum de = -1.6263032587282567e-19
Info: CFL hydro = 0.011184747005657181 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011184747005657181 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8842e+04 |  512 |      1 | 2.717e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1481.7400591455769 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.890636078266464, dt = 0.011184747005657181 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1402.00 ns (0.5%)
   gen split merge   : 700.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 940.00 ns  (0.3%)
   LB compute        : 289.95 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3901965516260882e-17,-7.919348770507595e-17,-1.3052669296971519e-17)
    sum a = (-7.349687265040261e-17,7.881586008839925e-17,-2.126058118619156e-17)
    sum e = 2.592001570462646
    sum de = 1.6675961149069038e-19
Info: CFL hydro = 0.011184736491087305 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011184736491087305 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9451e+04 |  512 |      1 | 2.632e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.6950600728649 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.90182082527212, dt = 0.011184736491087305 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.87 us    (1.3%)
   patch tree reduce : 1221.00 ns (0.4%)
   gen split merge   : 605.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 938.00 ns  (0.3%)
   LB compute        : 272.46 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2511476230048224e-17,-7.708287133589841e-17,-1.3695587632728268e-17)
    sum a = (-2.7757093498670394e-17,-7.041437745380907e-17,6.059605942021484e-18)
    sum e = 2.592001568627381
    sum de = 4.400931731027128e-19
Info: CFL hydro = 0.011177331791631068 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011177331791631068 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9393e+04 |  512 |      1 | 2.640e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1525.0903024611853 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.91300556176321, dt = 0.011177331791631068 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.5%)
   patch tree reduce : 1571.00 ns (0.5%)
   gen split merge   : 765.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 978.00 ns  (0.3%)
   LB compute        : 270.52 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1929.00 ns (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2441219929271163e-17,-7.85875271108738e-17,-1.3322716953083347e-17)
    sum a = (-1.1460559064258024e-17,-9.01505432804317e-17,1.8093632061372268e-16)
    sum e = 2.5920015664747966
    sum de = 2.9953202597280196e-19
Info: CFL hydro = 0.011170779912924273 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011170779912924273 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9524e+04 |  512 |      1 | 2.622e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1534.3994879946883 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.924182893554843, dt = 0.011170779912924273 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.4%)
   patch tree reduce : 1174.00 ns (0.4%)
   gen split merge   : 792.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1003.00 ns (0.3%)
   LB compute        : 288.97 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.249976684658538e-17,-7.948329494578133e-17,-1.0472030957230787e-17)
    sum a = (-1.910239544669623e-17,9.771480499742858e-18,2.6212186718041485e-17)
    sum e = 2.592001564223222
    sum de = -1.1365064569784575e-18
Info: CFL hydro = 0.011164385659107675 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011164385659107675 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9293e+04 |  512 |      1 | 2.654e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1515.3719586728369 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.935353673467766, dt = 0.011164385659107675 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.2%)
   patch tree reduce : 1758.00 ns (0.5%)
   gen split merge   : 792.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 990.00 ns  (0.3%)
   LB compute        : 318.20 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2288997944254199e-17,-7.929887215624154e-17,-1.108732246637989e-17)
    sum a = (4.0701816916843827e-17,4.7314691227484663e-17,1.654318161951017e-16)
    sum e = 2.592001562025103
    sum de = -7.36071631163987e-19
Info: CFL hydro = 0.011159137042279893 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011159137042279893 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9921e+04 |  512 |      1 | 2.570e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1563.7595406987614 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.946518059126873, dt = 0.011159137042279893 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.70 us    (1.2%)
   patch tree reduce : 1495.00 ns (0.5%)
   gen split merge   : 738.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 875.00 ns  (0.3%)
   LB compute        : 282.81 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.66 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3053035215204734e-17,-7.813378850168862e-17,-8.448686086674762e-18)
    sum a = (6.136521954643037e-17,5.674659960680506e-17,4.0530704403037194e-17)
    sum e = 2.592001560040506
    sum de = -1.6474790824096142e-18
Info: CFL hydro = 0.011155114129704376 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011155114129704376 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9792e+04 |  512 |      1 | 2.587e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1552.9033936442008 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.957677196169154, dt = 0.011155114129704376 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1678.00 ns (0.6%)
   gen split merge   : 716.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 931.00 ns  (0.3%)
   LB compute        : 277.77 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1883.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.388732878693233e-17,-7.762443032105492e-17,-8.65963794812255e-18)
    sum a = (-4.961265773206769e-17,8.120457431481931e-17,-5.925185879050373e-17)
    sum e = 2.59200155840566
    sum de = 8.03834266944331e-19
Info: CFL hydro = 0.011152377680467618 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011152377680467618 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0134e+04 |  512 |      1 | 2.543e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1579.1733890471085 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.968832310298858, dt = 0.011152377680467618 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.95 us    (1.3%)
   patch tree reduce : 1398.00 ns (0.4%)
   gen split merge   : 677.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 298.55 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2783719395559333e-17,-7.650911154621909e-17,-9.881987806173443e-18)
    sum a = (5.662950577217662e-17,-2.932468720975856e-17,-8.815775258234904e-17)
    sum e = 2.5920015572332016
    sum de = -3.2356658585114273e-19
Info: CFL hydro = 0.011150968539696566 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011150968539696566 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9166e+04 |  512 |      1 | 2.671e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1502.9090156282848 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.979984687979325, dt = 0.011150968539696566 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.4%)
   patch tree reduce : 1335.00 ns (0.4%)
   gen split merge   : 642.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1398.00 ns (0.5%)
   LB compute        : 288.90 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.41 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3872692057603775e-17,-7.72965675840953e-17,-1.0949737210691479e-17)
    sum a = (6.141278891674817e-17,-4.405911670658097e-17,-1.7426343571283475e-16)
    sum e = 2.5920015566032557
    sum de = -4.3283383604694747e-19
Info: CFL hydro = 0.011150906710226503 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011150906710226503 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9838e+04 |  512 |      1 | 2.581e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1555.4103719311652 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 21.99113565651902, dt = 0.008864343480979642 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1676.00 ns (0.5%)
   gen split merge   : 1114.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 907.00 ns  (0.3%)
   LB compute        : 290.55 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1939.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4317648629191825e-17,-7.785569064444608e-17,-1.2858000796901748e-17)
    sum a = (8.32771351877426e-17,-8.029453566881644e-17,-3.131381872550909e-17)
    sum e = 2.5920015451052274
    sum de = 5.099138342470888e-19
Info: CFL hydro = 0.011152061406890765 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011152061406890765 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0095e+04 |  512 |      1 | 2.548e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1252.4735783829951 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 2338                                                    [SPH][rank=0]
Info: time since start : 1823.7814854560002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.1499297100979398 max=0.1500859268969997 delta=0.00015621679905991614
Number of particle pairs: 130816
Distance min=0.129807 max=1.842392 mean=0.800498
---------------- t = 22, dt = 0.011152061406890765 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 10.00 us   (1.8%)
   patch tree reduce : 1936.00 ns (0.4%)
   gen split merge   : 454.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 909.00 ns  (0.2%)
   LB compute        : 525.59 us  (95.4%)
   LB move op cnt    : 0
   LB apply          : 4.68 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.95 us    (79.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.538320252431058e-17,-7.897393676514763e-17,-1.2840802639940697e-17)
    sum a = (-9.566566289143097e-18,-2.8581141359868003e-17,-5.533269155366671e-17)
    sum e = 2.5920015567633072
    sum de = 3.5914196963582334e-19
Info: CFL hydro = 0.011154159982154164 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011154159982154164 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5253e+04 |  512 |      1 | 3.357e-02 | 0.1% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1195.998140641339 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.01115206140689, dt = 0.011154159982154164 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.2%)
   patch tree reduce : 1186.00 ns (0.3%)
   gen split merge   : 769.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 976.00 ns  (0.3%)
   LB compute        : 324.72 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.484749823088549e-17,-7.881586008839925e-17,-1.3336438886828866e-17)
    sum a = (-3.3840118207617565e-17,1.4012326455398182e-16,1.2423655854076898e-17)
    sum e = 2.592001557827748
    sum de = -1.8482258909088833e-18
Info: CFL hydro = 0.011157794450470337 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011157794450470337 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5189e+04 |  512 |      1 | 3.371e-02 | 0.0% |   1.5% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1191.244854905073 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.022306221389044, dt = 0.011157794450470337 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.3%)
   patch tree reduce : 1589.00 ns (0.5%)
   gen split merge   : 739.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 871.00 ns  (0.3%)
   LB compute        : 291.99 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.54 us    (70.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4431815117954548e-17,-7.668767964402745e-17,-1.305980470251919e-17)
    sum a = (-6.6743485738207655e-18,3.631372546414324e-17,4.872713560769015e-17)
    sum e = 2.5920015593203796
    sum de = -2.490276864927643e-19
Info: CFL hydro = 0.011162666827211613 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011162666827211613 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9437e+04 |  512 |      1 | 2.634e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1524.8788008905694 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.033464015839513, dt = 0.011162666827211613 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.66 us    (1.6%)
   patch tree reduce : 1151.00 ns (0.4%)
   gen split merge   : 1099.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 900.00 ns  (0.3%)
   LB compute        : 275.22 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1958.00 ns (64.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4305939245728984e-17,-7.67286624861474e-17,-1.231753956644488e-17)
    sum a = (2.1311077902375074e-18,3.623468712576905e-17,5.576301139592621e-17)
    sum e = 2.592001561221451
    sum de = -1.2976544751935881e-18
Info: CFL hydro = 0.011168700802035508 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011168700802035508 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9180e+04 |  512 |      1 | 2.669e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1505.429094373908 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.044626682666724, dt = 0.011168700802035508 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.5%)
   patch tree reduce : 1717.00 ns (0.6%)
   gen split merge   : 729.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 975.00 ns  (0.3%)
   LB compute        : 282.31 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.446401592247737e-17,-7.652960296727906e-17,-1.1616531711165431e-17)
    sum a = (-6.542618009863777e-17,-5.660901435111665e-17,-5.0525989642169476e-17)
    sum e = 2.592001563409623
    sum de = -5.082197683525802e-21
Info: CFL hydro = 0.01117580284041092 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01117580284041092 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9629e+04 |  512 |      1 | 2.608e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1541.471896871149 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.05579538346876, dt = 0.01117580284041092 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.3%)
   patch tree reduce : 1342.00 ns (0.4%)
   gen split merge   : 676.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 912.00 ns  (0.3%)
   LB compute        : 306.90 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3404316719090036e-17,-7.759808420826353e-17,-1.275508629381035e-17)
    sum a = (-1.0362804364616451e-16,1.104194860546137e-17,-9.77235870350257e-17)
    sum e = 2.5920015657480366
    sum de = -7.928228386300251e-19
Info: CFL hydro = 0.011183602809035301 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011183602809035301 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9299e+04 |  512 |      1 | 2.653e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1516.5062742769373 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.06697118630917, dt = 0.011183602809035301 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 2.13 us    (0.7%)
   gen split merge   : 821.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 997.00 ns  (0.3%)
   LB compute        : 294.46 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.212213922990868e-17,-7.708579868176413e-17,-1.4404942997702906e-17)
    sum a = (7.501031046297512e-17,-5.684320202037351e-17,-5.597085295239168e-17)
    sum e = 2.5920015680908794
    sum de = 3.3203691532368573e-19
Info: CFL hydro = 0.011186563484434356 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011186563484434356 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9344e+04 |  512 |      1 | 2.647e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1521.1089437814207 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.078154789118205, dt = 0.011186563484434356 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.97 us    (1.3%)
   patch tree reduce : 1188.00 ns (0.4%)
   gen split merge   : 1013.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 911.00 ns  (0.3%)
   LB compute        : 286.78 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3817072486155268e-17,-7.818062603553998e-17,-1.4554809384093558e-17)
    sum a = (5.489358967381008e-17,-8.002778127680354e-17,1.1422503568003783e-17)
    sum e = 2.592001570257558
    sum de = 5.89534931288993e-19
Info: CFL hydro = 0.011182013420008324 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011182013420008324 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9964e+04 |  512 |      1 | 2.565e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1570.273937343951 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.089341352602638, dt = 0.011182013420008324 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.4%)
   patch tree reduce : 1357.00 ns (0.4%)
   gen split merge   : 736.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1165.00 ns (0.4%)
   LB compute        : 299.55 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.39 us    (70.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4244464982549055e-17,-7.912615875016459e-17,-1.4112139801463092e-17)
    sum a = (1.107122206411848e-16,1.150798206728254e-16,-4.397751694057428e-17)
    sum e = 2.592001572095186
    sum de = 3.2187251995663413e-19
Info: CFL hydro = 0.011177943398943643 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011177943398943643 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9984e+04 |  512 |      1 | 2.562e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1571.188645453271 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.100523366022646, dt = 0.011177943398943643 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.4%)
   patch tree reduce : 1178.00 ns (0.4%)
   gen split merge   : 749.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 924.00 ns  (0.3%)
   LB compute        : 293.96 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.60 us    (70.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6059419419289787e-17,-7.667304291469889e-17,-1.4894335764736866e-17)
    sum a = (2.5526455948998717e-18,-7.974090138196388e-18,3.6284452005486136e-17)
    sum e = 2.5920015735549926
    sum de = -1.4763784270642455e-18
Info: CFL hydro = 0.011174386912597293 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011174386912597293 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0166e+04 |  512 |      1 | 2.539e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1584.9584096846895 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.11170130942159, dt = 0.011174386912597293 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.4%)
   patch tree reduce : 1741.00 ns (0.6%)
   gen split merge   : 731.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 902.00 ns  (0.3%)
   LB compute        : 282.19 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.523976257689075e-17,-7.751611852402363e-17,-1.418280776025252e-17)
    sum a = (-8.431927031593566e-17,1.6891956583497958e-16,-2.88109380103263e-17)
    sum e = 2.592001574566922
    sum de = -2.371692252312041e-19
Info: CFL hydro = 0.011171369214953644 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011171369214953644 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9194e+04 |  512 |      1 | 2.667e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1508.0753142324065 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.122875696334187, dt = 0.011171369214953644 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.4%)
   patch tree reduce : 1431.00 ns (0.5%)
   gen split merge   : 804.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 277.07 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.385805532827522e-17,-7.47322126057326e-17,-1.4786572845055383e-17)
    sum a = (-1.5085198715181214e-16,6.530323157227791e-17,3.0292175018376e-17)
    sum e = 2.5920015750934504
    sum de = 1.283254915090265e-18
Info: CFL hydro = 0.011168907136988935 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011168907136988935 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8876e+04 |  512 |      1 | 2.712e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1482.6913963168827 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.13404706554914, dt = 0.011168907136988935 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.08 us    (1.3%)
   patch tree reduce : 1103.00 ns (0.3%)
   gen split merge   : 837.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 837.00 ns  (0.3%)
   LB compute        : 303.32 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.33 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2028464162205932e-17,-7.453022574099854e-17,-1.4074130044988003e-17)
    sum a = (4.8816419656594335e-17,3.009311549950766e-17,-3.6228832434037626e-17)
    sum e = 2.592001575133123
    sum de = 1.8465318250143747e-19
Info: CFL hydro = 0.011167009643212414 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011167009643212414 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0160e+04 |  512 |      1 | 2.540e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1583.1874373510411 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.145215972686128, dt = 0.011167009643212414 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 1359.00 ns (0.4%)
   gen split merge   : 728.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1390.00 ns (0.5%)
   LB compute        : 291.49 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1990.00 ns (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3594594200361244e-17,-7.439556783117585e-17,-1.475364020406614e-17)
    sum a = (1.257002314736244e-16,4.7856250212641173e-17,-1.5515518557440712e-16)
    sum e = 2.5920015747185663
    sum de = 1.5915749078908303e-18
Info: CFL hydro = 0.011165677220897844 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011165677220897844 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0284e+04 |  512 |      1 | 2.524e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1592.626079146913 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.15638298232934, dt = 0.011165677220897844 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.5%)
   patch tree reduce : 1290.00 ns (0.5%)
   gen split merge   : 706.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1446.00 ns (0.5%)
   LB compute        : 264.96 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.44 us    (71.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5384666197243433e-17,-7.376911581591372e-17,-1.7034957429037935e-17)
    sum a = (1.1847554187705e-16,6.262178275928675e-17,-5.1161223695028737e-17)
    sum e = 2.5920015739136626
    sum de = -4.514685608865421e-19
Info: CFL hydro = 0.011164902730936243 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011164902730936243 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9996e+04 |  512 |      1 | 2.561e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1569.8325951367601 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.16754865955024, dt = 0.011164902730936243 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1247.00 ns (0.4%)
   gen split merge   : 714.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 891.00 ns  (0.3%)
   LB compute        : 270.40 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.73 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1963.00 ns (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7010806825645818e-17,-7.30870442292031e-17,-1.7041178039002568e-17)
    sum a = (9.236361675490912e-17,-6.98816005062497e-17,-5.530780911380817e-17)
    sum e = 2.5920015728070007
    sum de = -4.97843614748715e-19
Info: CFL hydro = 0.01116376335507312 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01116376335507312 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9461e+04 |  512 |      1 | 2.631e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.747743721503 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.178713562281175, dt = 0.01116376335507312 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.4%)
   patch tree reduce : 1315.00 ns (0.4%)
   gen split merge   : 814.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 940.00 ns  (0.3%)
   LB compute        : 275.89 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.747186379949528e-17,-7.450680697407285e-17,-1.7809972246984884e-17)
    sum a = (-7.670817106508743e-17,7.88275694718621e-17,9.527047119956e-18)
    sum e = 2.592001571497937
    sum de = -4.529508685442371e-19
Info: CFL hydro = 0.011162863274261131 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011162863274261131 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9790e+04 |  512 |      1 | 2.587e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1553.4414440598143 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.189877325636246, dt = 0.011162863274261131 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1314.00 ns (0.4%)
   gen split merge   : 747.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 967.00 ns  (0.3%)
   LB compute        : 288.98 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1849.00 ns (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.592037049066852e-17,-7.284846554114766e-17,-1.7371236285361468e-17)
    sum a = (2.5631840400164308e-17,-6.696596402400168e-17,-5.318987437996636e-18)
    sum e = 2.5920015701067802
    sum de = 4.616329562535937e-20
Info: CFL hydro = 0.011162483473410853 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011162483473410853 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9887e+04 |  512 |      1 | 2.574e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1560.9422877740137 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.201040188910508, dt = 0.011162483473410853 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.5%)
   patch tree reduce : 1291.00 ns (0.5%)
   gen split merge   : 775.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 881.00 ns  (0.3%)
   LB compute        : 266.20 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.46 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6675625724021925e-17,-7.428286501534598e-17,-1.7370138530661828e-17)
    sum a = (6.31721237820404e-18,1.3465790982269965e-18,-5.5502477613877945e-17)
    sum e = 2.5920015687512428
    sum de = 2.7825032317303766e-19
Info: CFL hydro = 0.011162609150524938 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011162609150524938 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0489e+04 |  512 |      1 | 2.499e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1608.07481263626 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 22.212202672383917, dt = 0.011162609150524938 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.2%)
   patch tree reduce : 1361.00 ns (0.4%)
   gen split merge   : 676.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1006.00 ns (0.3%)
   LB compute        : 316.29 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (70.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6511694355542116e-17,-7.379985294750368e-17,-1.836177694267138e-17)
    sum a = (-7.605830028289962e-17,2.5421071497833124e-17,1.8933194855658142e-16)
    sum e = 2.5920015675383885
    sum de = -5.069492189316988e-19
Info: CFL hydro = 0.011163220023880226 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011163220023880226 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9749e+04 |  512 |      1 | 2.593e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1550.0114168551024 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.22336528153444, dt = 0.011163220023880226 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.5%)
   patch tree reduce : 1447.00 ns (0.5%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 873.00 ns  (0.3%)
   LB compute        : 274.97 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1928.00 ns (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.503045734749242e-17,-7.353492814665685e-17,-1.494775982678609e-17)
    sum a = (-6.967083160391852e-19,-7.083006056674002e-17,-5.4401795568370656e-17)
    sum e = 2.592001566558655
    sum de = -3.2695471764015993e-19
Info: CFL hydro = 0.011164291246089647 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011164291246089647 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9647e+04 |  512 |      1 | 2.606e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.11332859718 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 22.234528501558323, dt = 0.011164291246089647 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1423.00 ns (0.5%)
   gen split merge   : 677.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 909.00 ns  (0.3%)
   LB compute        : 280.15 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.33 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5557379603320376e-17,-7.476002239145685e-17,-1.6828213627272104e-17)
    sum a = (-1.4812370080496962e-17,2.3699792128795137e-17,-3.229740693638794e-17)
    sum e = 2.592001565880796
    sum de = -2.829090043829363e-19
Info: CFL hydro = 0.011165793579321764 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011165793579321764 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9923e+04 |  512 |      1 | 2.570e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1563.9028162202483 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.245692792804412, dt = 0.011165793579321764 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.20 us    (1.2%)
   patch tree reduce : 1519.00 ns (0.4%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 322.29 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.47 us    (70.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.535100171978776e-17,-7.398427573704347e-17,-1.7226881542358602e-17)
    sum a = (6.896241390441649e-17,3.867609357777191e-17,-1.168040273877291e-16)
    sum e = 2.5920015655466493
    sum de = -5.268544931921748e-19
Info: CFL hydro = 0.011167693904963562 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011167693904963562 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9722e+04 |  512 |      1 | 2.596e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1548.357339264122 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.256858586383736, dt = 0.011167693904963562 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.6%)
   patch tree reduce : 1341.00 ns (0.5%)
   gen split merge   : 689.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 921.00 ns  (0.3%)
   LB compute        : 271.13 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6723926930806155e-17,-7.347199021054407e-17,-1.8999206504929922e-17)
    sum a = (-1.3016736126469918e-16,1.1493930807127128e-16,-3.73529332464706e-18)
    sum e = 2.5920015655691753
    sum de = 3.2695471764015993e-19
Info: CFL hydro = 0.011169956024195345 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011169956024195345 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9167e+04 |  512 |      1 | 2.671e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1505.065560647639 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.268026280288698, dt = 0.011169956024195345 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.74 us    (1.6%)
   patch tree reduce : 1245.00 ns (0.4%)
   gen split merge   : 1052.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 901.00 ns  (0.3%)
   LB compute        : 273.14 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.81 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4351313106647502e-17,-7.175949287910322e-17,-1.8299387883908418e-17)
    sum a = (6.865211524265113e-17,-3.1568497815825936e-17,-3.920887052533128e-17)
    sum e = 2.5920015659327196
    sum de = 1.3400061225563031e-18
Info: CFL hydro = 0.011172541292448454 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011172541292448454 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9555e+04 |  512 |      1 | 2.618e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1535.8402789755403 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.27919623631289, dt = 0.011172541292448454 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1324.00 ns (0.4%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1316.00 ns (0.4%)
   LB compute        : 279.95 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6036000652364103e-17,-7.286090676107692e-17,-1.904275077468237e-17)
    sum a = (1.3162225215995748e-16,6.450113880507313e-17,1.0301915570609665e-16)
    sum e = 2.5920015665949525
    sum de = 4.9636130709102e-19
Info: CFL hydro = 0.011175409257996502 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011175409257996502 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9888e+04 |  512 |      1 | 2.574e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1562.3241208231088 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.29036877760534, dt = 0.011175409257996502 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.00 us    (1.3%)
   patch tree reduce : 1200.00 ns (0.4%)
   gen split merge   : 722.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1573.00 ns (0.5%)
   LB compute        : 298.26 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.37 us    (69.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.777923511539492e-17,-7.163727618920979e-17,-1.7171524974640217e-17)
    sum a = (3.77042147503559e-17,7.622808634311084e-18,5.439008618490781e-17)
    sum e = 2.59200156749187
    sum de = -6.505213034913027e-19
Info: CFL hydro = 0.011178518393543202 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011178518393543202 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9741e+04 |  512 |      1 | 2.594e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1551.1935995225215 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.30154418686334, dt = 0.011178518393543202 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.5%)
   patch tree reduce : 1562.00 ns (0.5%)
   gen split merge   : 747.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 846.00 ns  (0.3%)
   LB compute        : 286.08 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1855.00 ns (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7713369833416427e-17,-7.193366995811301e-17,-1.671637986724612e-17)
    sum a = (3.0485379845512916e-17,-1.3387338113068913e-16,-1.147519579358658e-17)
    sum e = 2.5920015685435627
    sum de = -1.2874900798265365e-18
Info: CFL hydro = 0.011180464068616518 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011180464068616518 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0171e+04 |  512 |      1 | 2.538e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1585.4526477375555 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.31272270525688, dt = 0.011180464068616518 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.99 us    (1.3%)
   patch tree reduce : 1247.00 ns (0.4%)
   gen split merge   : 624.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 926.00 ns  (0.3%)
   LB compute        : 287.56 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.07 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8006104419987512e-17,-7.411307895513475e-17,-1.7470400126562424e-17)
    sum a = (-1.2086718344933577e-16,-5.792046529895511e-17,1.7593348652922282e-17)
    sum e = 2.592001569652675
    sum de = 3.5236570605778894e-19
Info: CFL hydro = 0.011178901939965607 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011178901939965607 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9734e+04 |  512 |      1 | 2.595e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1551.331538875259 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.323903169325497, dt = 0.011178901939965607 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.3%)
   patch tree reduce : 1522.00 ns (0.5%)
   gen split merge   : 814.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 963.00 ns  (0.3%)
   LB compute        : 308.30 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5990626791445585e-17,-7.450095228234143e-17,-1.6960676027695522e-17)
    sum a = (5.488773498207866e-19,7.010993348377514e-17,4.2329421218179066e-17)
    sum e = 2.592001570712898
    sum de = 3.5575383784680614e-19
Info: CFL hydro = 0.011177724768078335 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011177724768078335 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9358e+04 |  512 |      1 | 2.645e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1521.6055901085083 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.335082071265465, dt = 0.011177724768078335 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.29 us    (1.5%)
   patch tree reduce : 1251.00 ns (0.4%)
   gen split merge   : 671.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 916.00 ns  (0.3%)
   LB compute        : 277.83 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1888.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6868830551158843e-17,-7.288066634567048e-17,-1.6398991539712248e-17)
    sum a = (1.139205917100039e-16,-6.258665460889823e-18,4.9800007867473185e-17)
    sum e = 2.5920015716652958
    sum de = 6.505213034913027e-19
Info: CFL hydro = 0.011176918366291358 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011176918366291358 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9248e+04 |  512 |      1 | 2.660e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1512.739976248742 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.346259796033543, dt = 0.011176918366291358 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1411.00 ns (0.5%)
   gen split merge   : 668.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 963.00 ns  (0.3%)
   LB compute        : 286.72 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1870.00 ns (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8568154826203997e-17,-7.3401733909767e-17,-1.5784980744379394e-17)
    sum a = (7.764053072331633e-18,-1.3892012540317465e-16,-2.1451590503929196e-17)
    sum e = 2.59200157244015
    sum de = 5.759824041329242e-20
Info: CFL hydro = 0.011176465747079856 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011176465747079856 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9917e+04 |  512 |      1 | 2.571e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1565.2462670498685 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.357436714399835, dt = 0.011176465747079856 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.5%)
   patch tree reduce : 1610.00 ns (0.5%)
   gen split merge   : 735.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 932.00 ns  (0.3%)
   LB compute        : 280.37 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.46 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1952.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7773380423663498e-17,-7.565176512579902e-17,-1.6361667879924436e-17)
    sum a = (7.905151143058897e-17,4.284170674467846e-17,1.0232830208178889e-16)
    sum e = 2.5920015729865185
    sum de = -7.216720710606639e-19
Info: CFL hydro = 0.011176347861511251 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011176347861511251 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9758e+04 |  512 |      1 | 2.591e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1552.6610575020309 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.368613180146916, dt = 0.011176347861511251 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.4%)
   patch tree reduce : 1006.00 ns (0.3%)
   gen split merge   : 684.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 741.00 ns  (0.3%)
   LB compute        : 273.80 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.48 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9297063946766003e-17,-7.415552547018755e-17,-1.4562082008978682e-17)
    sum a = (-1.0276996538927801e-17,3.253744929737623e-17,-1.3641431734212617e-16)
    sum e = 2.592001573275949
    sum de = 1.6601845766184287e-19
Info: CFL hydro = 0.011176543731749127 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011176543731749127 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0206e+04 |  512 |      1 | 2.534e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1587.8433110169065 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.379789528008427, dt = 0.011176543731749127 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.77 us    (1.3%)
   patch tree reduce : 1003.00 ns (0.4%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 806.00 ns  (0.3%)
   LB compute        : 265.86 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.65 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1923.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8473016085568394e-17,-7.393085167499425e-17,-1.741112137278178e-17)
    sum a = (1.2922951283297206e-17,1.1248326488993986e-16,-2.2664682630679776e-16)
    sum e = 2.592001573304296
    sum de = -1.07742590890747e-18
Info: CFL hydro = 0.011177031081261666 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011177031081261666 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0429e+04 |  512 |      1 | 2.506e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1605.4032025623235 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.390966071740177, dt = 0.011177031081261666 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.5%)
   patch tree reduce : 1455.00 ns (0.5%)
   gen split merge   : 799.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 871.00 ns  (0.3%)
   LB compute        : 264.77 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.881990657065513e-17,-7.201856298821863e-17,-2.0449706381389654e-17)
    sum a = (6.866821564491254e-17,1.744990870550245e-17,1.0725795251964598e-16)
    sum e = 2.592001573091407
    sum de = 9.486769009248164e-20
Info: CFL hydro = 0.011177786969864312 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011177786969864312 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0150e+04 |  512 |      1 | 2.541e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1583.571126615796 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.402143102821437, dt = 0.011177786969864312 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.91 us    (1.2%)
   patch tree reduce : 1897.00 ns (0.6%)
   gen split merge   : 796.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 731.00 ns  (0.2%)
   LB compute        : 303.71 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.23 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.979764008980256e-17,-7.248218138970058e-17,-1.7326228342676165e-17)
    sum a = (-1.2845998678852332e-16,-6.434891682005617e-17,1.8875526142103638e-17)
    sum e = 2.592001572678174
    sum de = -1.1180834903756764e-19
Info: CFL hydro = 0.011178459656767635 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011178459656767635 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0390e+04 |  512 |      1 | 2.511e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1602.5063230654678 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.4133208897913, dt = 0.011178459656767635 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1253.00 ns (0.4%)
   gen split merge   : 702.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 950.00 ns  (0.3%)
   LB compute        : 287.04 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7452836051368158e-17,-7.359603649160357e-17,-1.7748497983804955e-17)
    sum a = (-1.2787378577891473e-17,6.066046102926048e-17,5.302008831975513e-17)
    sum e = 2.592001572121297
    sum de = 1.8566962203814263e-18
Info: CFL hydro = 0.011178794749863358 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011178794749863358 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0109e+04 |  512 |      1 | 2.546e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1580.5278422752792 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.42449934944807, dt = 0.011178794749863358 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.5%)
   patch tree reduce : 1236.00 ns (0.4%)
   gen split merge   : 753.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 865.00 ns  (0.3%)
   LB compute        : 272.85 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.48 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.816710844260161e-17,-7.218286027493164e-17,-1.6883467280487396e-17)
    sum a = (-6.691180812548603e-17,-3.9788485006742034e-17,-3.522182545623309e-17)
    sum e = 2.5920015714902345
    sum de = 1.1096131609031334e-18
Info: CFL hydro = 0.0111793531666197 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0111793531666197 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9404e+04 |  512 |      1 | 2.639e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1525.1718807656064 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.435678144197933, dt = 0.0111793531666197 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.06 us    (1.4%)
   patch tree reduce : 1240.00 ns (0.4%)
   gen split merge   : 715.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 865.00 ns  (0.3%)
   LB compute        : 271.80 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7063499051228615e-17,-7.331812159347764e-17,-1.777045307779779e-17)
    sum a = (1.2149949015632933e-17,5.777556167860243e-17,-1.5692915716902788e-16)
    sum e = 2.5920015708659654
    sum de = -2.812149384884277e-19
Info: CFL hydro = 0.011180124269986876 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011180124269986876 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9854e+04 |  512 |      1 | 2.579e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1560.6499035678673 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.44685749736455, dt = 0.011180124269986876 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.83 us    (1.3%)
   patch tree reduce : 1165.00 ns (0.4%)
   gen split merge   : 791.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 933.00 ns  (0.3%)
   LB compute        : 272.76 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1920.00 ns (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7498209912286676e-17,-7.199532718040955e-17,-2.029089786817484e-17)
    sum a = (5.8707921336831335e-18,7.769029560303342e-17,-6.042041866827219e-18)
    sum e = 2.592001570324615
    sum de = 1.0079692072326174e-18
Info: CFL hydro = 0.011181098476925519 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011181098476925519 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9438e+04 |  512 |      1 | 2.634e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.0635761215442 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.45803762163454, dt = 0.011181098476925519 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.5%)
   patch tree reduce : 1577.00 ns (0.5%)
   gen split merge   : 658.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 917.00 ns  (0.3%)
   LB compute        : 271.21 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1905.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7546511119070906e-17,-7.111657454334647e-17,-1.9417085127260148e-17)
    sum a = (2.4951232486386532e-17,1.5804008492506515e-16,5.4179317282576634e-17)
    sum e = 2.5920015699345287
    sum de = -2.913793338554793e-19
Info: CFL hydro = 0.011182267479376243 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011182267479376243 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9759e+04 |  512 |      1 | 2.591e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1553.3656699520986 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.469218720111463, dt = 0.011182267479376243 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.3%)
   patch tree reduce : 1555.00 ns (0.5%)
   gen split merge   : 805.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 799.00 ns  (0.3%)
   LB compute        : 287.18 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1959.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.799146769065896e-17,-6.877103866844564e-17,-1.849350750662837e-17)
    sum a = (7.868559319737511e-17,1.1823403584312885e-16,7.504543861336366e-17)
    sum e = 2.5920015697507233
    sum de = -3.2271955290388843e-19
Info: CFL hydro = 0.011183624124055344 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011183624124055344 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9537e+04 |  512 |      1 | 2.621e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.0968487191683 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.48040098759084, dt = 0.011183624124055344 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.02 us    (1.2%)
   patch tree reduce : 1344.00 ns (0.4%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 893.00 ns  (0.3%)
   LB compute        : 308.20 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9169724401607578e-17,-6.766944182735532e-17,-1.757432090479516e-17)
    sum a = (-1.3587275835696965e-17,1.2187272675420747e-16,-2.230637549671677e-17)
    sum e = 2.5920015698101673
    sum de = -1.4399560103323106e-20
Info: CFL hydro = 0.011185162645842234 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011185162645842234 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9517e+04 |  512 |      1 | 2.623e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1534.7376254551245 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.491584611714895, dt = 0.008415388285104797 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.5%)
   patch tree reduce : 1217.00 ns (0.4%)
   gen split merge   : 848.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1187.00 ns (0.4%)
   LB compute        : 263.30 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.75 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8837470645849397e-17,-6.673488665972713e-17,-1.8332503484014274e-17)
    sum a = (-4.8491484265500425e-18,8.087817525079255e-17,-6.108199883392284e-17)
    sum e = 2.592001555251225
    sum de = 4.705268021997638e-19
Info: CFL hydro = 0.01118647605655912 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01118647605655912 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9927e+04 |  512 |      1 | 2.569e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1179.0985689475895 (tsim/hr)                            [sph::Model][rank=0]
Info: iteration since start : 2383                                                    [SPH][rank=0]
Info: time since start : 1825.591239901 (s)                                           [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14992787084421644 max=0.1500836963320815 delta=0.00015582548786505224
Number of particle pairs: 130816
Distance min=0.128476 max=1.840843 mean=0.800585
---------------- t = 22.5, dt = 0.01118647605655912 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 10.79 us   (1.4%)
   patch tree reduce : 1270.00 ns (0.2%)
   gen split merge   : 495.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.1%)
   LB compute        : 746.47 us  (96.5%)
   LB move op cnt    : 0
   LB apply          : 6.06 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.33 us    (79.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8809660860125142e-17,-6.613084713624936e-17,-1.9200461533197543e-17)
    sum a = (-8.539067890278584e-18,1.1841114026800438e-16,-1.17503663049634e-17)
    sum e = 2.5920015703097397
    sum de = 1.1418004128987969e-18
Info: CFL hydro = 0.011188284799834977 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011188284799834977 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6257e+04 |  512 |      1 | 3.149e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1278.719324632552 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.511186476056558, dt = 0.011188284799834977 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.3%)
   patch tree reduce : 1326.00 ns (0.4%)
   gen split merge   : 725.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1181.00 ns (0.4%)
   LB compute        : 297.54 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.48 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1922.00 ns (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8718913138288107e-17,-6.448622763706966e-17,-1.8961882845142107e-17)
    sum a = (1.0677640412473654e-16,-2.302064788795022e-17,4.648039765575707e-17)
    sum e = 2.592001571147833
    sum de = 2.05829006182795e-18
Info: CFL hydro = 0.011190305652258984 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011190305652258984 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9407e+04 |  512 |      1 | 2.638e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1526.7312469206793 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.522374760856394, dt = 0.011190305652258984 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.2%)
   patch tree reduce : 1260.00 ns (0.4%)
   gen split merge   : 1090.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 851.00 ns  (0.3%)
   LB compute        : 319.02 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.34 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.32 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.041823741333326e-17,-6.531997233144744e-17,-1.8036841551577476e-17)
    sum a = (-9.44069041691753e-18,-1.7319641814478314e-17,-4.4952323113856e-17)
    sum e = 2.5920015720776006
    sum de = -8.538092108323347e-19
Info: CFL hydro = 0.011192497967102958 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011192497967102958 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9821e+04 |  512 |      1 | 2.583e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1559.552812967222 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.533565066508654, dt = 0.011192497967102958 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.65 us    (1.6%)
   patch tree reduce : 1267.00 ns (0.4%)
   gen split merge   : 733.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1238.00 ns (0.4%)
   LB compute        : 281.82 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1935.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9965962477080935e-17,-6.554789365096052e-17,-1.923998070238464e-17)
    sum a = (-1.6378646485945557e-16,-4.81475211262794e-17,-1.2455490740366504e-17)
    sum e = 2.5920015731392816
    sum de = -1.7533582008164017e-19
Info: CFL hydro = 0.011194861718634099 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011194861718634099 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7408e+04 |  512 |      1 | 2.941e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1369.9685379975392 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.544757564475756, dt = 0.011194861718634099 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.54 us    (1.5%)
   patch tree reduce : 1816.00 ns (0.6%)
   gen split merge   : 954.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1082.00 ns (0.4%)
   LB compute        : 287.71 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 3.60 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.30 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7152783100132796e-17,-6.637555495471112e-17,-1.9125814213621915e-17)
    sum a = (3.067858467264983e-17,-2.8409891626723914e-18,1.2426583199942609e-17)
    sum e = 2.592001574260956
    sum de = -9.944166800765486e-19
Info: CFL hydro = 0.011197397121832495 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011197397121832495 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9745e+04 |  512 |      1 | 2.593e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1554.2265707566994 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.55595242619439, dt = 0.011197397121832495 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.08 us    (1.7%)
   patch tree reduce : 1527.00 ns (0.5%)
   gen split merge   : 720.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1332.00 ns (0.5%)
   LB compute        : 277.31 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8780387401468036e-17,-6.600224974716425e-17,-1.8901872254895036e-17)
    sum a = (1.159726611618672e-16,4.211865231584788e-17,1.695518725419731e-17)
    sum e = 2.592001575367152
    sum de = -5.539595475043124e-19
Info: CFL hydro = 0.011200104722890094 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011200104722890094 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9854e+04 |  512 |      1 | 2.579e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1563.1354603275545 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.567149823316225, dt = 0.011200104722890094 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1684.00 ns (0.6%)
   gen split merge   : 641.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 908.00 ns  (0.3%)
   LB compute        : 276.45 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2000.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.019136810874067e-17,-6.530764546096605e-17,-1.8597428284861107e-17)
    sum a = (-8.07581540702984e-17,-1.1245106408541704e-16,-1.1082931447581323e-17)
    sum e = 2.5920015763839217
    sum de = -1.9871392942585886e-18
Info: CFL hydro = 0.0112029853451893 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0112029853451893 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9975e+04 |  512 |      1 | 2.563e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1573.0098764123732 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.578349928039113, dt = 0.0112029853451893 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.5%)
   patch tree reduce : 1359.00 ns (0.5%)
   gen split merge   : 654.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 929.00 ns  (0.3%)
   LB compute        : 272.04 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.71 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8312012062954295e-17,-6.739427131597849e-17,-1.890333592782789e-17)
    sum a = (6.05053116983778e-17,-1.1325901154435324e-17,1.9103859119629085e-17)
    sum e = 2.5920015772449423
    sum de = 7.352245982167327e-19
Info: CFL hydro = 0.011205023337977238 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011205023337977238 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9389e+04 |  512 |      1 | 2.641e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.2576256261234 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.589552913384303, dt = 0.011205023337977238 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.59 us    (1.5%)
   patch tree reduce : 1283.00 ns (0.4%)
   gen split merge   : 706.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1218.00 ns (0.4%)
   LB compute        : 295.42 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9933761672558116e-17,-6.701197824182832e-17,-1.8516926273554057e-17)
    sum a = (-7.394329289492351e-17,-6.289695327066358e-17,2.4513594279462757e-17)
    sum e = 2.5920015778900476
    sum de = 1.260385025514399e-18
Info: CFL hydro = 0.011205071369043895 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011205071369043895 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9184e+04 |  512 |      1 | 2.669e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1511.4090015956747 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.60075793672228, dt = 0.011205071369043895 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.73 us    (1.7%)
   patch tree reduce : 1410.00 ns (0.5%)
   gen split merge   : 734.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 891.00 ns  (0.3%)
   LB compute        : 267.83 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.43 us    (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8254928818572934e-17,-6.792759714088769e-17,-1.826956554790149e-17)
    sum a = (-8.311320381926279e-17,8.362548934576219e-17,5.828345618630327e-17)
    sum e = 2.592001578275881
    sum de = 5.793705359219414e-19
Info: CFL hydro = 0.011205428663442499 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011205428663442499 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9377e+04 |  512 |      1 | 2.642e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1526.654593005138 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.611963008091326, dt = 0.011205428663442499 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.73 us    (1.6%)
   patch tree reduce : 1325.00 ns (0.4%)
   gen split merge   : 862.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 921.00 ns  (0.3%)
   LB compute        : 287.24 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7258167551298385e-17,-6.610075036156751e-17,-1.7454299724301016e-17)
    sum a = (1.3964025248613953e-16,-3.10737763645208e-17,-8.235794858590938e-17)
    sum e = 2.5920015784046604
    sum de = 1.0164395367051604e-18
Info: CFL hydro = 0.011206140493507023 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011206140493507023 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9905e+04 |  512 |      1 | 2.572e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1568.2589802754014 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.623168436754767, dt = 0.011206140493507023 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.4%)
   patch tree reduce : 1208.00 ns (0.4%)
   gen split merge   : 844.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 936.00 ns  (0.3%)
   LB compute        : 296.93 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9894242503371017e-17,-6.71988709794423e-17,-1.903213914591917e-17)
    sum a = (-4.541777110650402e-17,-8.580050732398536e-17,6.700109217439021e-17)
    sum e = 2.5920015782848784
    sum de = -6.403569081242511e-19
Info: CFL hydro = 0.011207248853786244 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011207248853786244 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9641e+04 |  512 |      1 | 2.607e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1547.5424523563934 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.634374577248273, dt = 0.011207248853786244 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.3%)
   patch tree reduce : 1313.00 ns (0.4%)
   gen split merge   : 780.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1182.00 ns (0.3%)
   LB compute        : 322.08 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.85 us    (71.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8427642224649876e-17,-6.838499493240501e-17,-1.757139355892945e-17)
    sum a = (-9.975809241169475e-17,9.827100071191363e-18,-2.166235940626038e-18)
    sum e = 2.592001577945969
    sum de = 1.3552527156068805e-20
Info: CFL hydro = 0.011208791353332543 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011208791353332543 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9244e+04 |  512 |      1 | 2.661e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1516.4715600289358 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.64558182610206, dt = 0.011208791353332543 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1367.00 ns (0.4%)
   gen split merge   : 751.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 920.00 ns  (0.3%)
   LB compute        : 292.58 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6864439532360275e-17,-6.767712611025281e-17,-1.8110025198220246e-17)
    sum a = (6.3801503143168236e-18,-1.2311831242006744e-16,2.3418766925686897e-18)
    sum e = 2.5920015774360126
    sum de = -4.0318768289304696e-19
Info: CFL hydro = 0.011210800264907447 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011210800264907447 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9927e+04 |  512 |      1 | 2.569e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1570.5216710289378 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.656790617455393, dt = 0.011210800264907447 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1441.00 ns (0.5%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 986.00 ns  (0.3%)
   LB compute        : 282.00 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7610912728116544e-17,-6.984757011056081e-17,-1.800903176585322e-17)
    sum a = (-2.7894678754358805e-17,1.297428961141711e-16,8.714123173048094e-17)
    sum e = 2.592001576816639
    sum de = -2.202285662861181e-19
Info: CFL hydro = 0.011213301712206074 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011213301712206074 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9806e+04 |  512 |      1 | 2.585e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1561.2014495308995 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.6680014177203, dt = 0.011213301712206074 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1255.00 ns (0.4%)
   gen split merge   : 685.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 891.00 ns  (0.3%)
   LB compute        : 278.90 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.713521902493853e-17,-6.701206972138663e-17,-1.6576095964587755e-17)
    sum a = (9.865960587558675e-17,-1.3597521546226953e-17,-2.0922326371408672e-16)
    sum e = 2.5920015761594963
    sum de = -6.776263578034403e-20
Info: CFL hydro = 0.01121631550959547 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01121631550959547 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9489e+04 |  512 |      1 | 2.627e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.5586373197857 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.679214719432508, dt = 0.01121631550959547 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.6%)
   patch tree reduce : 1451.00 ns (0.5%)
   gen split merge   : 963.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1111.00 ns (0.4%)
   LB compute        : 264.46 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.49 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.889455389023076e-17,-6.81709327659749e-17,-2.0532403902095984e-17)
    sum a = (-2.1921063597142576e-17,6.131911384904542e-17,5.2996669552829444e-17)
    sum e = 2.592001575538396
    sum de = 9.961107459710572e-19
Info: CFL hydro = 0.011219853722540502 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011219853722540502 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9614e+04 |  512 |      1 | 2.610e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1546.8246421148906 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.690431034942105, dt = 0.011219853722540502 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1294.00 ns (0.4%)
   gen split merge   : 796.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1178.00 ns (0.4%)
   LB compute        : 284.01 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8003177074121802e-17,-6.690156241495604e-17,-1.8473016085568394e-17)
    sum a = (-1.0867762378495744e-16,6.133082323250827e-17,-7.083006056674002e-17)
    sum e = 2.592001575023128
    sum de = -1.1248597539537109e-18
Info: CFL hydro = 0.011221970869480558 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011221970869480558 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9587e+04 |  512 |      1 | 2.614e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1545.2433109414158 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.701650888664645, dt = 0.011221970869480558 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.24 us    (1.4%)
   patch tree reduce : 1442.00 ns (0.5%)
   gen split merge   : 763.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 280.00 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6136994084731127e-17,-6.61217906599773e-17,-1.9926443307893836e-17)
    sum a = (-4.8426167860871754e-17,2.6870107701360002e-17,-9.223481353681784e-17)
    sum e = 2.5920015746613556
    sum de = -2.236166980751353e-19
Info: CFL hydro = 0.011219866230406631 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011219866230406631 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.5408e+04 |  512 |      1 | 3.323e-02 | 0.0% |   1.6% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1215.7972657831476 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.712872859534126, dt = 0.011219866230406631 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.2%)
   patch tree reduce : 1419.00 ns (0.4%)
   gen split merge   : 1074.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 926.00 ns  (0.3%)
   LB compute        : 335.77 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6330198911868042e-17,-6.617777614965903e-17,-2.1144219188029555e-17)
    sum a = (4.2696071287859346e-17,-8.530285852681451e-18,-1.2411946470614055e-18)
    sum e = 2.592001574481248
    sum de = 1.2874900798265365e-18
Info: CFL hydro = 0.011218072957436787 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011218072957436787 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9984e+04 |  512 |      1 | 2.562e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1576.4925896105697 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.72409272576453, dt = 0.011218072957436787 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.65 us    (1.6%)
   patch tree reduce : 1609.00 ns (0.6%)
   gen split merge   : 688.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 947.00 ns  (0.3%)
   LB compute        : 272.42 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7258167551298385e-17,-6.650490705015222e-17,-2.06410816173605e-17)
    sum a = (1.0250979752546296e-16,-1.6105525116674734e-17,2.7259444701499547e-17)
    sum e = 2.5920015745369094
    sum de = -6.335806445462167e-19
Info: CFL hydro = 0.011216597791435011 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011216597791435011 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9613e+04 |  512 |      1 | 2.610e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1547.03791050157 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 22.73531079872197, dt = 0.011216597791435011 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.02 us    (1.7%)
   patch tree reduce : 1832.00 ns (0.6%)
   gen split merge   : 805.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 992.00 ns  (0.3%)
   LB compute        : 284.25 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8696958044295274e-17,-6.662456231241314e-17,-2.012952792732753e-17)
    sum a = (-1.832686834322278e-16,-3.429678416266846e-17,-4.4062409970679894e-17)
    sum e = 2.59200157483275
    sum de = -3.3881317890172014e-19
Info: CFL hydro = 0.011215445705273415 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011215445705273415 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9625e+04 |  512 |      1 | 2.609e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1547.756023595108 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.746527396513404, dt = 0.011215445705273415 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.26 us    (1.4%)
   patch tree reduce : 1472.00 ns (0.5%)
   gen split merge   : 735.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 938.00 ns  (0.3%)
   LB compute        : 277.40 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.62 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1954.00 ns (64.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4951419009118228e-17,-6.718405129099714e-17,-2.1095414843674657e-17)
    sum a = (-7.238155387556677e-17,-5.8662181557679606e-18,-5.421444543296516e-18)
    sum e = 2.592001575351181
    sum de = 2.270048298641525e-19
Info: CFL hydro = 0.011214619909409316 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011214619909409316 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9610e+04 |  512 |      1 | 2.611e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1546.4373943907963 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.757742842218676, dt = 0.011214619909409316 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.99 us    (1.6%)
   patch tree reduce : 1843.00 ns (0.6%)
   gen split merge   : 980.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 917.00 ns  (0.3%)
   LB compute        : 290.63 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4743577452652757e-17,-6.705854133700478e-17,-2.0805653342748434e-17)
    sum a = (-1.34714993067081e-16,-1.6994898530456846e-16,-7.87221850206965e-17)
    sum e = 2.592001576054439
    sum de = -1.8058742435461683e-18
Info: CFL hydro = 0.011214121852674726 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011214121852674726 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9421e+04 |  512 |      1 | 2.636e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.3621712303884 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.768957462128085, dt = 0.011214121852674726 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.86 us    (1.7%)
   patch tree reduce : 1568.00 ns (0.6%)
   gen split merge   : 807.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 918.00 ns  (0.3%)
   LB compute        : 267.13 us  (93.7%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1947.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2881785482060649e-17,-6.97388923952963e-17,-2.2044195082619038e-17)
    sum a = (-7.471318485760547e-17,6.530140198111184e-17,-1.2216399766784568e-16)
    sum e = 2.5920015768881144
    sum de = -3.1509625637859973e-19
Info: CFL hydro = 0.011213951340877487 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011213951340877487 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9346e+04 |  512 |      1 | 2.647e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1525.4233583309024 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.78017158398076, dt = 0.011213951340877487 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.97 us    (1.7%)
   patch tree reduce : 1426.00 ns (0.5%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1011.00 ns (0.4%)
   LB compute        : 268.05 us  (93.7%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2439756256338307e-17,-6.769816640866261e-17,-2.3680764380668016e-17)
    sum a = (-1.9932297999625258e-17,-1.8244097638869805e-16,-5.831272964496037e-17)
    sum e = 2.5920015777860677
    sum de = 3.6930636500287495e-19
Info: CFL hydro = 0.011214106858523826 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011214106858523826 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9230e+04 |  512 |      1 | 2.663e-02 | 0.1% |   2.1% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1516.2455710405152 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.791385535321638, dt = 0.011214106858523826 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.4%)
   patch tree reduce : 1434.00 ns (0.4%)
   gen split merge   : 1081.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 925.00 ns  (0.3%)
   LB compute        : 301.32 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.42 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.42 us    (69.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2679798617326599e-17,-7.11015718957847e-17,-2.3878726144836716e-17)
    sum a = (-5.316060092130925e-17,6.113908207830421e-17,-9.762112992972582e-17)
    sum e = 2.592001578675622
    sum de = -7.707999820014133e-19
Info: CFL hydro = 0.011214585310992203 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011214585310992203 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9838e+04 |  512 |      1 | 2.581e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1564.192955692462 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.802599642180162, dt = 0.011214585310992203 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.81 us    (1.7%)
   patch tree reduce : 1258.00 ns (0.5%)
   gen split merge   : 754.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 924.00 ns  (0.3%)
   LB compute        : 262.59 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1931.00 ns (64.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1770857726023375e-17,-6.922550911409725e-17,-2.532593275719752e-17)
    sum a = (6.786465920477492e-17,3.740123445325483e-17,3.208371068819105e-17)
    sum e = 2.5920015794843203
    sum de = 3.6507120026660345e-19
Info: CFL hydro = 0.011215381814147867 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011215381814147867 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9420e+04 |  512 |      1 | 2.636e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.324454968332 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.813814227491154, dt = 0.011215381814147867 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.4%)
   patch tree reduce : 1421.00 ns (0.5%)
   gen split merge   : 884.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 949.00 ns  (0.3%)
   LB compute        : 292.08 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1970.00 ns (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3145246609974625e-17,-6.873554459982389e-17,-2.421317540999418e-17)
    sum a = (7.277089087570632e-17,-9.740743368152893e-17,-9.777335191474278e-17)
    sum e = 2.5920015801461482
    sum de = 1.2781727174067392e-18
Info: CFL hydro = 0.011216490232984466 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011216490232984466 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9973e+04 |  512 |      1 | 2.563e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1575.0327128210229 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.8250296093053, dt = 0.011216490232984466 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.80 us    (1.6%)
   patch tree reduce : 1522.00 ns (0.5%)
   gen split merge   : 622.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1522.00 ns (0.5%)
   LB compute        : 275.94 us  (93.6%)
   LB move op cnt    : 0
   LB apply          : 3.30 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4218118869757658e-17,-7.076163385712903e-17,-2.602849576496813e-17)
    sum a = (3.8295538615229496e-17,-1.0056457619769809e-16,-4.248164320319603e-17)
    sum e = 2.5920015806076133
    sum de = 1.666537323722836e-19
Info: CFL hydro = 0.011217903316720464 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011217903316720464 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0186e+04 |  512 |      1 | 2.536e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1591.9574228171014 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.836246099538286, dt = 0.011217903316720464 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.56 us    (1.5%)
   patch tree reduce : 1389.00 ns (0.5%)
   gen split merge   : 694.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 926.00 ns  (0.3%)
   LB compute        : 285.82 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4431815117954548e-17,-7.183523795337848e-17,-2.6087774518748772e-17)
    sum a = (1.290374057605348e-17,-1.9715674405562655e-17,9.663754171884697e-17)
    sum e = 2.5920015808330077
    sum de = 9.978048118655658e-19
Info: CFL hydro = 0.011219612494267608 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011219612494267608 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9993e+04 |  512 |      1 | 2.561e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1576.9374518099635 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.847464002855006, dt = 0.011219612494267608 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.3%)
   patch tree reduce : 1153.00 ns (0.4%)
   gen split merge   : 693.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 980.00 ns  (0.3%)
   LB compute        : 296.91 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (70.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4387904929968888e-17,-7.169509127005757e-17,-2.431380292412799e-17)
    sum a = (-5.622260469684282e-17,5.1023638439340324e-18,-2.7038430088638377e-17)
    sum e = 2.5920015808083576
    sum de = 2.574980159653073e-19
Info: CFL hydro = 0.011221608106403047 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011221608106403047 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9720e+04 |  512 |      1 | 2.596e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1555.676875283318 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.858683615349275, dt = 0.011221608106403047 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.62 us    (1.5%)
   patch tree reduce : 1375.00 ns (0.5%)
   gen split merge   : 645.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 944.00 ns  (0.3%)
   LB compute        : 283.56 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1896.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3344306128842964e-17,-7.16350806798105e-17,-2.5251285437621894e-17)
    sum a = (-1.4212264178026236e-17,-3.4885180681676344e-17,1.7217417982052109e-16)
    sum e = 2.592001580542273
    sum de = -7.182839392716467e-19
Info: CFL hydro = 0.011223879285220742 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011223879285220742 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0072e+04 |  512 |      1 | 2.551e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1583.6995616734773 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.869905223455678, dt = 0.011223879285220742 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 1347.00 ns (0.4%)
   gen split merge   : 822.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 938.00 ns  (0.3%)
   LB compute        : 286.60 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.55 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3569711760502701e-17,-7.218798313019665e-17,-2.2274906528660376e-17)
    sum a = (-4.9021333867194094e-17,1.4728647988737632e-16,-7.835626678748264e-17)
    sum e = 2.5920015800664413
    sum de = 1.0164395367051604e-20
Info: CFL hydro = 0.011223099190948943 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011223099190948943 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9478e+04 |  512 |      1 | 2.629e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.1596831192653 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.8811291027409, dt = 0.011223099190948943 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.4%)
   patch tree reduce : 1420.00 ns (0.5%)
   gen split merge   : 718.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1547.00 ns (0.5%)
   LB compute        : 280.99 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.19 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2827629583544996e-17,-6.954038175377778e-17,-2.4526767335858458e-17)
    sum a = (5.1603252920751077e-17,3.118501550741781e-17,-4.820753171652647e-17)
    sum e = 2.5920015794123916
    sum de = 1.7787691892340307e-19
Info: CFL hydro = 0.01121971457492697 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01121971457492697 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9816e+04 |  512 |      1 | 2.584e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1563.735151188841 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.89235220193185, dt = 0.01121971457492697 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.4%)
   patch tree reduce : 1579.00 ns (0.5%)
   gen split merge   : 749.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 970.00 ns  (0.3%)
   LB compute        : 287.67 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.02 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4003690785094335e-17,-6.9728555205208e-17,-2.4919031681863713e-17)
    sum a = (-5.70539709227047e-17,-1.4886724665486017e-16,1.499532919710389e-16)
    sum e = 2.5920015786542323
    sum de = -7.064254780100865e-19
Info: CFL hydro = 0.011216961505079196 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011216961505079196 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0044e+04 |  512 |      1 | 2.554e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1581.2684478079304 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.903571916506777, dt = 0.011216961505079196 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.18 us    (1.2%)
   patch tree reduce : 1473.00 ns (0.4%)
   gen split merge   : 732.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 329.17 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.48 us    (71.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2470493387928272e-17,-7.279366928572388e-17,-2.2048769060534213e-17)
    sum a = (-7.875145847935361e-17,-2.8764685945648073e-16,-3.166217288352868e-17)
    sum e = 2.5920015778944863
    sum de = 3.015437292225309e-19
Info: CFL hydro = 0.011214869467700337 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011214869467700337 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9992e+04 |  512 |      1 | 2.561e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1576.791635831664 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.914788878011855, dt = 0.011214869467700337 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.4%)
   patch tree reduce : 1323.00 ns (0.5%)
   gen split merge   : 704.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 824.00 ns  (0.3%)
   LB compute        : 270.77 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.40 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1471536611254441e-17,-7.640949030722661e-17,-2.355854769077459e-17)
    sum a = (5.796730283280649e-17,-4.497574188078168e-17,3.858241851006916e-17)
    sum e = 2.592001577218458
    sum de = -1.0842021724855044e-18
Info: CFL hydro = 0.011213460040623294 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011213460040623294 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9490e+04 |  512 |      1 | 2.627e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.8787075801738 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.926003747479555, dt = 0.011213460040623294 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.5%)
   patch tree reduce : 1413.00 ns (0.5%)
   gen split merge   : 726.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 964.00 ns  (0.3%)
   LB compute        : 270.34 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2834216111742846e-17,-7.57310092931794e-17,-2.262728578724532e-17)
    sum a = (-2.8319143904886876e-17,-1.1657569441020366e-16,-7.494590885392949e-17)
    sum e = 2.5920015767085514
    sum de = 3.2526065174565133e-19
Info: CFL hydro = 0.011212746602125859 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011212746602125859 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9427e+04 |  512 |      1 | 2.635e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.7487713855448 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.937217207520177, dt = 0.011212746602125859 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.92 us    (1.6%)
   patch tree reduce : 1347.00 ns (0.5%)
   gen split merge   : 838.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 985.00 ns  (0.3%)
   LB compute        : 281.63 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.60 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1999.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2152876361498644e-17,-7.739349017611783e-17,-2.4201100108298122e-17)
    sum a = (6.58945554371515e-17,4.3737474579585987e-17,6.420840421850204e-17)
    sum e = 2.5920015764373154
    sum de = 1.616138863361205e-18
Info: CFL hydro = 0.011212734290393687 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011212734290393687 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8770e+04 |  512 |      1 | 2.728e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1479.8265118975248 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.948429954122304, dt = 0.011212734290393687 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.3%)
   patch tree reduce : 1371.00 ns (0.4%)
   gen split merge   : 874.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 923.00 ns  (0.3%)
   LB compute        : 298.60 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.35 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.57 us    (69.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3429199158948579e-17,-7.601105109103587e-17,-2.26452157806728e-17)
    sum a = (1.1849310595224427e-16,1.2604858563164401e-16,-1.1312435363453054e-16)
    sum e = 2.592001576460486
    sum de = 1.6195269951502222e-18
Info: CFL hydro = 0.011213419860187307 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011213419860187307 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8765e+04 |  512 |      1 | 2.728e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1479.4542295203416 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.959642688412696, dt = 0.011213419860187307 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.22 us    (1.8%)
   patch tree reduce : 1214.00 ns (0.4%)
   gen split merge   : 762.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 919.00 ns  (0.3%)
   LB compute        : 278.48 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5006306744100306e-17,-7.418800071338529e-17,-2.5034295925326077e-17)
    sum a = (9.834711170442212e-17,1.0354022327019318e-17,1.9712747059696946e-17)
    sum e = 2.5920015768122195
    sum de = -5.421010862427522e-20
Info: CFL hydro = 0.011214791717175656 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011214791717175656 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9109e+04 |  512 |      1 | 2.679e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1506.6699338054293 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.970856108272883, dt = 0.011214791717175656 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.5%)
   patch tree reduce : 2.18 us    (0.7%)
   gen split merge   : 863.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 992.00 ns  (0.3%)
   LB compute        : 285.60 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.18 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.596940353391918e-17,-7.465793120439019e-17,-2.3989965287733727e-17)
    sum a = (-1.7325789240796307e-16,-1.4577889676653523e-16,7.892709923129627e-17)
    sum e = 2.59200157750125
    sum de = 7.318364664277155e-19
Info: CFL hydro = 0.011216829989414203 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011216829989414203 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9688e+04 |  512 |      1 | 2.601e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1552.5046044314981 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 22.98207089999006, dt = 0.011216829989414203 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.12 us    (1.5%)
   patch tree reduce : 2.10 us    (0.6%)
   gen split merge   : 682.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 916.00 ns  (0.3%)
   LB compute        : 319.31 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2402432596550495e-17,-7.707591888946735e-17,-2.2734545569356133e-17)
    sum a = (1.1533742710900796e-18,-5.905334814898522e-17,1.610040226140974e-18)
    sum e = 2.592001578509241
    sum de = -4.845028458294598e-19
Info: CFL hydro = 0.011219506479160554 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011219506479160554 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9402e+04 |  512 |      1 | 2.639e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1530.238364385116 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 22.993287729979475, dt = 0.006712270020525324 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.46 us    (1.4%)
   patch tree reduce : 1379.00 ns (0.4%)
   gen split merge   : 930.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 295.99 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.90 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.351848320785276e-17,-7.718514548208169e-17,-2.3251908211341375e-17)
    sum a = (-6.423182298542773e-17,3.8977610201940127e-17,1.0300159163090238e-16)
    sum e = 2.5920015575388367
    sum de = -7.318364664277155e-19
Info: CFL hydro = 0.011221591689708842 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011221591689708842 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9235e+04 |  512 |      1 | 2.662e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 907.8305717804569 (tsim/hr)                             [sph::Model][rank=0]
Info: iteration since start : 2428                                                    [SPH][rank=0]
Info: time since start : 1827.5424362420001 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14993975287022018 max=0.15007099212893252 delta=0.00013123925871233455
Number of particle pairs: 130816
Distance min=0.127213 max=1.837622 mean=0.800567
---------------- t = 23, dt = 0.011221591689708842 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.32 us    (1.7%)
   patch tree reduce : 1466.00 ns (0.3%)
   gen split merge   : 471.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 916.00 ns  (0.2%)
   LB compute        : 516.51 us  (95.6%)
   LB move op cnt    : 0
   LB apply          : 4.45 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.91 us    (79.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.259453966898777e-17,-7.644763728303916e-17,-2.1721546680482718e-17)
    sum a = (9.085310628820231e-17,-5.0045904920192895e-17,-1.027615492699141e-16)
    sum e = 2.592001580135663
    sum de = 1.7279472123987727e-19
Info: CFL hydro = 0.011222850960375575 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011222850960375575 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.6266e+04 |  512 |      1 | 3.148e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1283.416942784721 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 23.011221591689708, dt = 0.011222850960375575 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.66 us    (1.5%)
   patch tree reduce : 1308.00 ns (0.4%)
   gen split merge   : 746.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1258.00 ns (0.4%)
   LB compute        : 296.18 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (64.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.456574119131082e-17,-7.746306038020762e-17,-2.4081993723387013e-17)
    sum a = (-4.783283144571549e-18,3.688163056209115e-17,3.1931488703174085e-17)
    sum e = 2.592001581933521
    sum de = 6.911788849595091e-19
Info: CFL hydro = 0.011221212309025496 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011221212309025496 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9550e+04 |  512 |      1 | 2.619e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.6963874156502 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.022444442650084, dt = 0.011221212309025496 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.3%)
   patch tree reduce : 1035.00 ns (0.3%)
   gen split merge   : 709.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 791.00 ns  (0.2%)
   LB compute        : 304.65 us  (95.3%)
   LB move op cnt    : 0
   LB apply          : 2.78 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3800240247427431e-17,-7.638579710162602e-17,-2.304735991897483e-17)
    sum a = (-4.011049305197023e-17,-1.1280527293516807e-17,8.978169770135214e-17)
    sum e = 2.5920015835090395
    sum de = 3.3881317890172014e-20
Info: CFL hydro = 0.01122008175952653 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01122008175952653 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8920e+04 |  512 |      1 | 2.706e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1492.7895953729624 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.03366565495911, dt = 0.01122008175952653 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.4%)
   patch tree reduce : 1405.00 ns (0.5%)
   gen split merge   : 828.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 900.00 ns  (0.3%)
   LB compute        : 277.12 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3504578314990634e-17,-7.690851129777201e-17,-2.175347304633063e-17)
    sum a = (-1.3260876771670204e-16,-1.4086534673093954e-16,-2.340120285049263e-17)
    sum e = 2.592001585028849
    sum de = -3.5914196963582334e-19
Info: CFL hydro = 0.011219448134055636 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011219448134055636 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9829e+04 |  512 |      1 | 2.582e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1564.3018908038139 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.044885736718633, dt = 0.011219448134055636 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.4%)
   patch tree reduce : 2.18 us    (0.7%)
   gen split merge   : 777.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 992.00 ns  (0.3%)
   LB compute        : 299.39 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.24 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1250887916626484e-17,-7.915378557677225e-17,-2.2613014976149982e-17)
    sum a = (4.396873490297715e-18,1.1731192189542995e-16,-1.7910087475592196e-16)
    sum e = 2.592001586383707
    sum de = -7.894347068410079e-19
Info: CFL hydro = 0.011219294167987785 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011219294167987785 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9667e+04 |  512 |      1 | 2.603e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1551.4974358661257 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.05610518485269, dt = 0.011219294167987785 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.81 us    (1.6%)
   patch tree reduce : 1225.00 ns (0.4%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1331.00 ns (0.5%)
   LB compute        : 277.42 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1910272572877856e-17,-7.657936784699614e-17,-2.5529383294864426e-17)
    sum a = (7.116085064956534e-17,-2.8657252352376485e-17,1.2312416711179884e-16)
    sum e = 2.5920015874735722
    sum de = -1.212951180468158e-18
Info: CFL hydro = 0.01121959562344628 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01121959562344628 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9481e+04 |  512 |      1 | 2.628e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.743364140118 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 23.067324479020677, dt = 0.01121959562344628 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.3%)
   patch tree reduce : 1138.00 ns (0.4%)
   gen split merge   : 1062.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 856.00 ns  (0.3%)
   LB compute        : 289.84 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.39 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.29 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3440908542411423e-17,-7.772652150812159e-17,-2.2333819364207807e-17)
    sum a = (-1.514901485505371e-17,2.0991558101132735e-16,-5.395098430505119e-17)
    sum e = 2.5920015882145933
    sum de = -2.0201735792015063e-18
Info: CFL hydro = 0.011220321642482971 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011220321642482971 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9360e+04 |  512 |      1 | 2.645e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.232227198524 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 23.078544074644125, dt = 0.011220321642482971 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.4%)
   patch tree reduce : 1800.00 ns (0.6%)
   gen split merge   : 684.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 928.00 ns  (0.3%)
   LB compute        : 300.23 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2553739785984425e-17,-7.427005787718349e-17,-2.3976792231338028e-17)
    sum a = (3.5549688193192705e-17,5.213602986831045e-18,-9.435128459772679e-17)
    sum e = 2.59200158854602
    sum de = -3.6083603553033194e-19
Info: CFL hydro = 0.011221435335348985 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011221435335348985 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9208e+04 |  512 |      1 | 2.666e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1515.3468328440395 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.089764396286608, dt = 0.011221435335348985 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.4%)
   patch tree reduce : 1426.00 ns (0.5%)
   gen split merge   : 680.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 979.00 ns  (0.3%)
   LB compute        : 290.75 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.29 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3229773721847026e-17,-7.530048362191371e-17,-2.529153644327542e-17)
    sum a = (2.7657563739236224e-17,-8.456919246922073e-17,-5.566348163649204e-18)
    sum e = 2.592001588435676
    sum de = 9.275010772434589e-19
Info: CFL hydro = 0.011222894311302726 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011222894311302726 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9297e+04 |  512 |      1 | 2.653e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1522.545398298532 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 23.100985831621955, dt = 0.011222894311302726 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.3%)
   patch tree reduce : 1214.00 ns (0.4%)
   gen split merge   : 756.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1530.00 ns (0.5%)
   LB compute        : 312.53 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (69.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3349428984107958e-17,-7.671878269385063e-17,-2.4866339456280916e-17)
    sum a = (8.5864908933031e-17,-2.461531954829621e-17,-1.10416558708748e-16)
    sum e = 2.592001587883457
    sum de = 1.6379234919734016e-18
Info: CFL hydro = 0.01122465148798565 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01122465148798565 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9364e+04 |  512 |      1 | 2.644e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.0267004666787 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.112208725933257, dt = 0.01122465148798565 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.6%)
   patch tree reduce : 1656.00 ns (0.6%)
   gen split merge   : 731.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 857.00 ns  (0.3%)
   LB compute        : 278.17 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4476274183290033e-17,-7.668694780756102e-17,-2.6520289870407555e-17)
    sum a = (4.818996764133221e-17,-4.7283176519649115e-17,-1.732403283327688e-17)
    sum e = 2.5920015869224304
    sum de = -6.378158092824882e-19
Info: CFL hydro = 0.01122665596316453 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01122665596316453 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9715e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1555.9938701236683 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.123433377421243, dt = 0.01122665596316453 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1262.00 ns (0.4%)
   gen split merge   : 733.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1077.00 ns (0.4%)
   LB compute        : 285.25 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.480340508378322e-17,-7.744439855031371e-17,-2.6382704614719144e-17)
    sum a = (6.506611655715533e-17,-3.635031728746463e-18,1.183855259916794e-16)
    sum e = 2.592001585617724
    sum de = -7.623296525288703e-20
Info: CFL hydro = 0.011228854037974264 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011228854037974264 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9612e+04 |  512 |      1 | 2.611e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1548.1020015179315 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.134660033384407, dt = 0.011228854037974264 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1424.00 ns (0.5%)
   gen split merge   : 620.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 993.00 ns  (0.3%)
   LB compute        : 277.70 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1985.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6009471580456098e-17,-7.718569435943151e-17,-2.418573154250314e-17)
    sum a = (-1.124393547019542e-17,1.770085542984051e-16,2.1073962887252494e-17)
    sum e = 2.592001584062376
    sum de = -1.1849990932087662e-18
Info: CFL hydro = 0.011231190109152687 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011231190109152687 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9711e+04 |  512 |      1 | 2.597e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1556.2736315405002 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.14588888742238, dt = 0.011231190109152687 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.5%)
   patch tree reduce : 1414.00 ns (0.5%)
   gen split merge   : 668.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1105.00 ns (0.4%)
   LB compute        : 294.88 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1911.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.494140625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5208756724098268e-17,-7.421297463280213e-17,-2.4479929802007083e-17)
    sum a = (8.396213412031894e-17,1.0010644656971434e-16,-6.91819648443448e-17)
    sum e = 2.592001582371486
    sum de = 8.690558038829121e-19
Info: CFL hydro = 0.011233607697988259 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011233607697988259 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9422e+04 |  512 |      1 | 2.636e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.7441595625032 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.157120077531534, dt = 0.011233607697988259 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.80 us    (1.7%)
   patch tree reduce : 1348.00 ns (0.5%)
   gen split merge   : 693.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1135.00 ns (0.4%)
   LB compute        : 273.38 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1930.00 ns (67.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6683035568244505e-17,-7.341527288439593e-17,-2.5759911781789156e-17)
    sum a = (2.989405598063932e-17,7.02855742357178e-18,-8.963533040806659e-18)
    sum e = 2.5920015806743986
    sum de = -6.2511031507367365e-19
Info: CFL hydro = 0.011234983348910979 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011234983348910979 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9396e+04 |  512 |      1 | 2.640e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1532.0293992730512 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.168353685229523, dt = 0.011234983348910979 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 1338.00 ns (0.4%)
   gen split merge   : 776.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 845.00 ns  (0.3%)
   LB compute        : 288.36 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6577879815974672e-17,-7.388986883287429e-17,-2.5627815299598955e-17)
    sum a = (-1.2887201071912212e-16,5.987885968311568e-17,8.488132072215215e-17)
    sum e = 2.5920015790999282
    sum de = 3.6761229910836635e-19
Info: CFL hydro = 0.0112335996356708 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0112335996356708 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9732e+04 |  512 |      1 | 2.595e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1558.7418937219609 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.179588668578432, dt = 0.0112335996356708 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1173.00 ns (0.4%)
   gen split merge   : 710.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 796.00 ns  (0.3%)
   LB compute        : 284.53 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.97 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.34 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4214093769192305e-17,-7.308118953747166e-17,-2.398630610540159e-17)
    sum a = (-3.614393940393201e-17,4.7658654366705685e-17,-4.039151825507847e-17)
    sum e = 2.592001577769317
    sum de = -1.2874900798265365e-19
Info: CFL hydro = 0.011229898219355772 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011229898219355772 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9470e+04 |  512 |      1 | 2.630e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.8364465448278 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.190822268214102, dt = 0.011229898219355772 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.10 us    (1.4%)
   patch tree reduce : 1305.00 ns (0.4%)
   gen split merge   : 763.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 781.00 ns  (0.3%)
   LB compute        : 275.03 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1966.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.433438938836136e-17,-7.251054005277465e-17,-2.529995256263934e-17)
    sum a = (-9.717470968520492e-17,6.137326974756107e-17,4.6972191761196493e-17)
    sum e = 2.592001576801159
    sum de = -8.639736061993863e-20
Info: CFL hydro = 0.011227020663113891 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011227020663113891 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9560e+04 |  512 |      1 | 2.618e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1544.468200972051 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 23.202052166433457, dt = 0.011227020663113891 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1300.00 ns (0.4%)
   gen split merge   : 724.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 845.00 ns  (0.3%)
   LB compute        : 283.41 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3039313281459213e-17,-7.172125442373237e-17,-2.410413177649645e-17)
    sum a = (-2.7212607167648172e-17,-5.844446020891735e-17,-1.635917963593858e-16)
    sum e = 2.5920015763024296
    sum de = 1.0299920638612292e-18
Info: CFL hydro = 0.011224990445232117 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011224990445232117 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9739e+04 |  512 |      1 | 2.594e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1558.2030150528246 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.21327918709657, dt = 0.011224990445232117 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.03 us    (1.3%)
   patch tree reduce : 2.03 us    (0.6%)
   gen split merge   : 736.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 809.00 ns  (0.3%)
   LB compute        : 305.34 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.05 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2658392400683588e-17,-7.321017571467955e-17,-2.713283699280755e-17)
    sum a = (1.1026433672373104e-16,-1.4730843498136913e-16,-6.763339888138375e-17)
    sum e = 2.592001576331109
    sum de = -1.2163393122571753e-18
Info: CFL hydro = 0.011223818361600602 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011223818361600602 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9679e+04 |  512 |      1 | 2.602e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1553.1440972205085 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.224504177541803, dt = 0.011223818361600602 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.4%)
   patch tree reduce : 1103.00 ns (0.4%)
   gen split merge   : 789.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 738.00 ns  (0.3%)
   LB compute        : 271.51 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1836.00 ns (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5029542551909386e-17,-7.528090699643678e-17,-2.7369769048813525e-17)
    sum a = (-1.055659466092651e-16,-1.1473293018773867e-16,5.881623313386264e-17)
    sum e = 2.5920015769100337
    sum de = -1.0164395367051604e-19
Info: CFL hydro = 0.011223503120214685 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011223503120214685 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9876e+04 |  512 |      1 | 2.576e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1568.5473839209862 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.235727995903403, dt = 0.011223503120214685 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.4%)
   patch tree reduce : 1684.00 ns (0.6%)
   gen split merge   : 1143.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 792.00 ns  (0.3%)
   LB compute        : 269.31 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.65 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1965.00 ns (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2780243172343802e-17,-7.633621518102554e-17,-2.5943602734862514e-17)
    sum a = (-3.415919890698005e-17,1.178549445535193e-17,-2.9671577694845294e-17)
    sum e = 2.5920015780243
    sum de = 9.046311876675928e-19
Info: CFL hydro = 0.0112240306028552 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0112240306028552 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9758e+04 |  512 |      1 | 2.591e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1559.1691870463749 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.246951499023616, dt = 0.0112240306028552 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.34 us    (1.4%)
   patch tree reduce : 1462.00 ns (0.5%)
   gen split merge   : 753.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 777.00 ns  (0.3%)
   LB compute        : 286.12 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1991.00 ns (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2623996086761485e-17,-7.554253853318468e-17,-2.6875962393091424e-17)
    sum a = (1.1664887805684642e-16,1.0040942686681543e-16,-9.876279481735307e-17)
    sum e = 2.5920015796221403
    sum de = -8.131516293641283e-19
Info: CFL hydro = 0.011225374166861448 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011225374166861448 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9674e+04 |  512 |      1 | 2.602e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1552.63629057943 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 23.25817552962647, dt = 0.011225374166861448 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.95 us    (1.4%)
   patch tree reduce : 1355.00 ns (0.5%)
   gen split merge   : 670.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 888.00 ns  (0.3%)
   LB compute        : 272.74 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.65 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.45 us    (70.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4940624421238417e-17,-7.38422994625565e-17,-2.844222965058419e-17)
    sum a = (-7.789667348656603e-18,4.201912255641371e-17,3.5854132163226634e-17)
    sum e = 2.5920015816172537
    sum de = 1.692371828614092e-18
Info: CFL hydro = 0.011227496338236607 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011227496338236607 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9070e+04 |  512 |      1 | 2.685e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1505.1332047166275 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.269400903793333, dt = 0.011227496338236607 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.20 us    (1.7%)
   patch tree reduce : 1144.00 ns (0.4%)
   gen split merge   : 953.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 951.00 ns  (0.3%)
   LB compute        : 291.69 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.42 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3976246917603298e-17,-7.387294511458815e-17,-2.7192298705704804e-17)
    sum a = (9.860764548647039e-17,-5.040889580754104e-17,-2.1071035541386785e-17)
    sum e = 2.5920015838939507
    sum de = 2.0769247866675444e-18
Info: CFL hydro = 0.011230348624262542 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011230348624262542 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9055e+04 |  512 |      1 | 2.687e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1504.264440450282 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 23.28062840013157, dt = 0.011230348624262542 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.95 us    (1.3%)
   patch tree reduce : 1428.00 ns (0.5%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 893.00 ns  (0.3%)
   LB compute        : 285.42 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.55 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (64.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5865848673919658e-17,-7.48722678094952e-17,-2.7749226256656296e-17)
    sum a = (3.921765256292842e-17,3.2367663237165e-17,-3.9642117713456494e-17)
    sum e = 2.592001586315756
    sum de = -2.0328790734103208e-19
Info: CFL hydro = 0.011233872353927242 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011233872353927242 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8641e+04 |  512 |      1 | 2.747e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1471.9830389820968 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.291858748755832, dt = 0.011233872353927242 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.4%)
   patch tree reduce : 1771.00 ns (0.5%)
   gen split merge   : 750.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 893.00 ns  (0.3%)
   LB compute        : 307.26 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.40 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5582627961412133e-17,-7.397668293370428e-17,-2.834274563092917e-17)
    sum a = (-2.6170472039455104e-18,-6.062826022473766e-17,-9.439226743984675e-17)
    sum e = 2.5920015887340733
    sum de = -1.4840017235895342e-18
Info: CFL hydro = 0.0112379997265032 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0112379997265032 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9139e+04 |  512 |      1 | 2.675e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1511.79008755656 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 23.30309262110976, dt = 0.0112379997265032 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (1.5%)
   patch tree reduce : 2.17 us    (0.7%)
   gen split merge   : 763.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 971.00 ns  (0.3%)
   LB compute        : 276.77 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.09 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (66.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5588848571376766e-17,-7.521787758076569e-17,-2.9654928415234067e-17)
    sum a = (-7.74282981480523e-17,-7.792594694522314e-18,3.4042105072351614e-17)
    sum e = 2.5920015909983745
    sum de = 1.1773757966834775e-18
Info: CFL hydro = 0.01124265482549953 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01124265482549953 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9113e+04 |  512 |      1 | 2.679e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1510.2265476282366 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.314330620836262, dt = 0.01124265482549953 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.4%)
   patch tree reduce : 1271.00 ns (0.4%)
   gen split merge   : 816.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 913.00 ns  (0.3%)
   LB compute        : 289.74 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.42 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.47 us    (70.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4236048863185135e-17,-7.506533541729466e-17,-2.8581873196334426e-17)
    sum a = (-7.262745092828649e-17,1.0442135437577215e-16,1.263179014512894e-16)
    sum e = 2.5920015929668727
    sum de = -1.111307226797642e-18
Info: CFL hydro = 0.011242608223432867 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011242608223432867 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8877e+04 |  512 |      1 | 2.712e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1492.2339633346908 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.32557327566176, dt = 0.011242608223432867 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.49 us    (1.5%)
   patch tree reduce : 1410.00 ns (0.5%)
   gen split merge   : 676.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1158.00 ns (0.4%)
   LB compute        : 284.73 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3245142287642008e-17,-7.310872488452101e-17,-2.668422123888736e-17)
    sum a = (-3.2657470477870375e-17,-1.725670387836553e-17,-1.3809754121490992e-17)
    sum e = 2.5920015944782437
    sum de = -1.24090326772755e-18
Info: CFL hydro = 0.011241889400902282 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011241889400902282 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9528e+04 |  512 |      1 | 2.622e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1543.6893719521483 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.336815883885194, dt = 0.011241889400902282 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.5%)
   patch tree reduce : 1568.00 ns (0.5%)
   gen split merge   : 697.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 953.00 ns  (0.3%)
   LB compute        : 290.33 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.40 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (68.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3172324559232452e-17,-7.41858966835443e-17,-2.755583847040277e-17)
    sum a = (-1.809158291926627e-16,-1.5708137915404486e-17,5.748099750086527e-17)
    sum e = 2.5920015954650997
    sum de = -3.163668057994812e-19
Info: CFL hydro = 0.011241136148325618 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011241136148325618 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9215e+04 |  512 |      1 | 2.665e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.8418541756143 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.348057773286097, dt = 0.011241136148325618 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 1434.00 ns (0.5%)
   gen split merge   : 626.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1060.00 ns (0.3%)
   LB compute        : 297.11 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.26 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (69.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0291816227372964e-17,-7.43311662221302e-17,-2.6698492049982702e-17)
    sum a = (5.0420605191003887e-17,3.5602380418775506e-17,-3.112573675363717e-17)
    sum e = 2.5920015958749896
    sum de = 9.51588576681003e-19
Info: CFL hydro = 0.011240385975538987 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011240385975538987 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9140e+04 |  512 |      1 | 2.675e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1512.784459384389 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 23.359298909434422, dt = 0.011240385975538987 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.19 us    (1.7%)
   patch tree reduce : 1231.00 ns (0.4%)
   gen split merge   : 822.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 922.00 ns  (0.3%)
   LB compute        : 296.52 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.94 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1935.00 ns (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.25319676511082e-17,-7.359347506397107e-17,-2.7404348321852235e-17)
    sum a = (-6.064289695406622e-17,1.7126144252754826e-16,1.0686568817364073e-16)
    sum e = 2.5920015956906584
    sum de = 6.556035011748285e-19
Info: CFL hydro = 0.011239678197012696 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011239678197012696 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9396e+04 |  512 |      1 | 2.640e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1532.9222817187547 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.370539295409962, dt = 0.011239678197012696 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.4%)
   patch tree reduce : 1414.00 ns (0.4%)
   gen split merge   : 1091.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 932.00 ns  (0.3%)
   LB compute        : 307.76 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.17 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (69.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1159774276556234e-17,-7.074827784161671e-17,-2.5284583996844356e-17)
    sum a = (-4.559633920431239e-17,6.697767340746452e-18,-3.367325949327205e-17)
    sum e = 2.592001594935909
    sum de = 3.8201185921168945e-19
Info: CFL hydro = 0.011239053223042736 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011239053223042736 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9916e+04 |  512 |      1 | 2.571e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1573.9654027818137 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.381778973606973, dt = 0.011239053223042736 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.87 us    (1.6%)
   patch tree reduce : 1568.00 ns (0.5%)
   gen split merge   : 679.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 919.00 ns  (0.3%)
   LB compute        : 282.81 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.33 us    (70.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0666516498183953e-17,-7.158806018684252e-17,-2.661579452927637e-17)
    sum a = (-6.5631094309237524e-18,7.93427823442272e-17,-1.8957491826343543e-17)
    sum e = 2.5920015936740652
    sum de = 8.173867941003998e-19
Info: CFL hydro = 0.011238551545234546 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011238551545234546 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9500e+04 |  512 |      1 | 2.626e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1541.0107428874824 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.393018026830017, dt = 0.011238551545234546 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.58 us    (1.8%)
   patch tree reduce : 1558.00 ns (0.5%)
   gen split merge   : 764.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 942.00 ns  (0.3%)
   LB compute        : 287.40 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.24 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0714817704968183e-17,-7.048353599988649e-17,-2.664397023323384e-17)
    sum a = (1.145119155748775e-16,-1.015232819687184e-16,-2.326654494066993e-17)
    sum e = 2.5920015920026716
    sum de = -1.0960606337470646e-18
Info: CFL hydro = 0.01123821297105926 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01123821297105926 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9617e+04 |  512 |      1 | 2.610e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1550.1555532711607 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.40425657837525, dt = 0.01123821297105926 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.5%)
   patch tree reduce : 1175.00 ns (0.4%)
   gen split merge   : 719.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 880.00 ns  (0.3%)
   LB compute        : 267.26 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.48 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2731027169976539e-17,-7.251547994892305e-17,-2.6841749038285928e-17)
    sum a = (7.631005202735075e-17,5.554053311013218e-17,1.3780773397420453e-16)
    sum e = 2.5920015900480147
    sum de = 2.371692252312041e-19
Info: CFL hydro = 0.01123585201333816 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01123585201333816 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9924e+04 |  512 |      1 | 2.570e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1574.3682222723437 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.41549479134631, dt = 0.01123585201333816 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.5%)
   patch tree reduce : 1200.00 ns (0.4%)
   gen split merge   : 714.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 270.81 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.04 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1852.00 ns (62.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3462863636404254e-17,-7.114767759316964e-17,-2.4491136047899257e-17)
    sum a = (2.6439787859100506e-17,-6.001351759293839e-17,7.8909535156102e-17)
    sum e = 2.592001587941412
    sum de = -5.607358110823468e-19
Info: CFL hydro = 0.011229146534652562 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011229146534652562 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9729e+04 |  512 |      1 | 2.595e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1558.602923513964 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 23.426730643359647, dt = 0.011229146534652562 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.59 us    (1.5%)
   patch tree reduce : 1313.00 ns (0.4%)
   gen split merge   : 762.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1060.00 ns (0.4%)
   LB compute        : 285.21 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3474573019867097e-17,-7.232630022235147e-17,-2.398081733190338e-17)
    sum a = (-5.248145668046433e-17,1.2722245132379406e-17,5.584790442603182e-17)
    sum e = 2.592001585824693
    sum de = -5.793705359219414e-19
Info: CFL hydro = 0.011222772747126655 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011222772747126655 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9794e+04 |  512 |      1 | 2.587e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1562.841698011479 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 23.4379597898943, dt = 0.011222772747126655 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.5%)
   patch tree reduce : 1378.00 ns (0.5%)
   gen split merge   : 723.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 922.00 ns  (0.3%)
   LB compute        : 267.32 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.31 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.20 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2215814297611426e-17,-7.170680065352042e-17,-2.3523053622152844e-17)
    sum a = (1.0113979966031028e-16,6.498707821878113e-18,5.056111779255801e-17)
    sum e = 2.5920015838797776
    sum de = -1.1011428314305904e-18
Info: CFL hydro = 0.011216827957195401 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011216827957195401 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0164e+04 |  512 |      1 | 2.539e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1591.1116157562558 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.449182562641425, dt = 0.011216827957195401 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.47 us    (1.6%)
   patch tree reduce : 1644.00 ns (0.6%)
   gen split merge   : 745.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 903.00 ns  (0.3%)
   LB compute        : 266.51 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.35 us    (69.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.43776592194389e-17,-7.197245729083368e-17,-2.2907579153887136e-17)
    sum a = (9.393852883066156e-17,-4.149805499231718e-17,6.1591357014556536e-18)
    sum e = 2.592001582243246
    sum de = 2.642742795433417e-19
Info: CFL hydro = 0.011211405897508749 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011211405897508749 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9939e+04 |  512 |      1 | 2.568e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1572.560110358931 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 23.46039939059862, dt = 0.011211405897508749 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1562.00 ns (0.5%)
   gen split merge   : 706.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 916.00 ns  (0.3%)
   LB compute        : 272.96 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1923.00 ns (64.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.5225125847562192e-17,-7.233435042348218e-17,-2.307004684943409e-17)
    sum a = (-1.6085765532081188e-16,1.3236579800984804e-16,-5.787948245683516e-17)
    sum e = 2.5920015810278785
    sum de = 5.89534931288993e-19
Info: CFL hydro = 0.011206594456207593 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011206594456207593 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9537e+04 |  512 |      1 | 2.621e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1540.1324155094542 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.47161079649613, dt = 0.011206594456207593 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.88 us    (1.6%)
   patch tree reduce : 1321.00 ns (0.4%)
   gen split merge   : 791.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 954.00 ns  (0.3%)
   LB compute        : 280.53 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.41 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.02 us    (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1844041372666148e-17,-6.981939440660334e-17,-2.4079981173104337e-17)
    sum a = (-9.465865591362643e-17,1.1891757110277234e-16,-2.062022427806731e-17)
    sum e = 2.5920015803156966
    sum de = -1.5924219408380846e-19
Info: CFL hydro = 0.011202473746570204 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011202473746570204 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9504e+04 |  512 |      1 | 2.625e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.8313172138458 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.482817390952338, dt = 0.011202473746570204 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.3%)
   patch tree reduce : 1665.00 ns (0.5%)
   gen split merge   : 778.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1102.00 ns (0.3%)
   LB compute        : 324.28 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.34 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.26 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1186852225814058e-17,-6.87882368254067e-17,-2.4157921756778888e-17)
    sum a = (-7.847043327624536e-17,2.328791456548962e-16,4.1814208345813953e-17)
    sum e = 2.5920015801529575
    sum de = 1.1722935989999517e-18
Info: CFL hydro = 0.01119911528229581 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01119911528229581 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9130e+04 |  512 |      1 | 2.676e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1506.8497197251731 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.49401986469891, dt = 0.005980135301090428 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.16 us    (1.3%)
   patch tree reduce : 1384.00 ns (0.4%)
   gen split merge   : 702.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 908.00 ns  (0.3%)
   LB compute        : 299.88 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.11034228686413e-17,-6.679105510852545e-17,-2.3592212168230264e-17)
    sum a = (-2.136377012795787e-17,5.777117065980386e-17,-6.098246907448867e-17)
    sum e = 2.5920015603640727
    sum de = 2.1819568721270777e-18
Info: CFL hydro = 0.01119794512116929 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01119794512116929 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8987e+04 |  512 |      1 | 2.697e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 798.377791623273 (tsim/hr)                              [sph::Model][rank=0]
Info: iteration since start : 2473                                                    [SPH][rank=0]
Info: time since start : 1829.3626627840001 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.149924282537808 max=0.15007796002072865 delta=0.00015367748292063887
Number of particle pairs: 130816
Distance min=0.126148 max=1.836387 mean=0.800611
---------------- t = 23.5, dt = 0.01119794512116929 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 8.79 us    (1.1%)
   patch tree reduce : 1636.00 ns (0.2%)
   gen split merge   : 537.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 841.00 ns  (0.1%)
   LB compute        : 793.45 us  (96.9%)
   LB move op cnt    : 0
   LB apply          : 5.87 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.40 us    (81.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.093363680843007e-17,-6.647343808209582e-17,-2.4630688114091192e-17)
    sum a = (3.960698956306796e-17,5.429641111720507e-17,-4.599445824204906e-17)
    sum e = 2.5920015806267087
    sum de = 4.404571325722362e-19
Info: CFL hydro = 0.011195585553319187 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011195585553319187 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.4971e+04 |  512 |      1 | 3.420e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1178.738510050515 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 23.511197945121168, dt = 0.011195585553319187 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.76 us    (1.6%)
   patch tree reduce : 1509.00 ns (0.5%)
   gen split merge   : 794.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 889.00 ns  (0.3%)
   LB compute        : 286.45 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1674255312454918e-17,-6.605116844096704e-17,-2.504417571762285e-17)
    sum a = (-1.3664850501138304e-17,1.3804484898932712e-16,4.910915424316542e-17)
    sum e = 2.5920015819630473
    sum de = -4.3029273720518457e-19
Info: CFL hydro = 0.011194407339290821 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011194407339290821 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9040e+04 |  512 |      1 | 2.689e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1498.7906398406174 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.52239353067449, dt = 0.011194407339290821 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.3%)
   patch tree reduce : 1499.00 ns (0.4%)
   gen split merge   : 777.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 909.00 ns  (0.3%)
   LB compute        : 317.46 us  (91.9%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.38 us    (69.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1322973808569613e-17,-6.401300388196585e-17,-2.4054000978546154e-17)
    sum a = (-1.0993354664090571e-16,-1.0383295785676427e-16,-6.803151791912043e-18)
    sum e = 2.5920015835477996
    sum de = -1.026603932072212e-18
Info: CFL hydro = 0.011194161846883361 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011194161846883361 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9367e+04 |  512 |      1 | 2.644e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1524.3833459866507 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.533587938013778, dt = 0.011194161846883361 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.4%)
   patch tree reduce : 917.00 ns  (0.3%)
   gen split merge   : 722.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 872.00 ns  (0.3%)
   LB compute        : 294.64 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1880.00 ns (62.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.585594037270218e-18,-6.643245523997588e-17,-2.4310143741795852e-17)
    sum a = (-1.838841579004935e-16,-4.8778364160340094e-17,4.2153780466236414e-17)
    sum e = 2.5920015854359715
    sum de = -4.404571325722362e-20
Info: CFL hydro = 0.01119486767050225 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01119486767050225 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8927e+04 |  512 |      1 | 2.705e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1489.7367723479872 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.54478209986066, dt = 0.01119486767050225 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.4%)
   patch tree reduce : 1143.00 ns (0.4%)
   gen split merge   : 741.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 898.00 ns  (0.3%)
   LB compute        : 298.38 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.28 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.057830882228888e-18,-6.672299431714767e-17,-2.356220687310673e-17)
    sum a = (7.46824477260155e-17,-5.01278706044328e-17,-1.7500844523565816e-16)
    sum e = 2.5920015874978475
    sum de = 4.0657581468206416e-20
Info: CFL hydro = 0.01119653271356877 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01119653271356877 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9525e+04 |  512 |      1 | 2.622e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.8530136818258 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.555976967531162, dt = 0.01119653271356877 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.28 us    (1.5%)
   patch tree reduce : 1343.00 ns (0.5%)
   gen split merge   : 724.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 908.00 ns  (0.3%)
   LB compute        : 276.47 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1962.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.121609717555046e-18,-6.722869331544923e-17,-2.6821806494575772e-17)
    sum a = (1.0115736373550454e-16,-8.691582609882121e-17,7.709458071936126e-17)
    sum e = 2.592001589595536
    sum de = -1.2366681029912785e-18
Info: CFL hydro = 0.011199151973214182 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011199151973214182 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7259e+04 |  512 |      1 | 2.967e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1358.74905975913 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 23.56717350024473, dt = 0.011199151973214182 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.94 us    (1.7%)
   patch tree reduce : 1218.00 ns (0.4%)
   gen split merge   : 748.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 931.00 ns  (0.3%)
   LB compute        : 277.37 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.00 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.33 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.056186388348479e-17,-6.855331731968339e-17,-2.444187430575284e-17)
    sum a = (7.432531153039878e-17,3.733829651714204e-18,-2.01050114057022e-17)
    sum e = 2.5920015915921124
    sum de = -7.657177843178875e-19
Info: CFL hydro = 0.011202707543168869 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011202707543168869 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9433e+04 |  512 |      1 | 2.635e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1530.2592822005738 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.578372652217947, dt = 0.011202707543168869 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.5%)
   patch tree reduce : 1564.00 ns (0.5%)
   gen split merge   : 709.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 967.00 ns  (0.3%)
   LB compute        : 274.08 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1854.00 ns (63.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1094640831044167e-17,-6.801175833452688e-17,-2.5273240531614727e-17)
    sum a = (7.099106458935412e-17,5.365239502674868e-17,-4.609984269321465e-17)
    sum e = 2.5920015933600835
    sum de = 1.1858461261560205e-20
Info: CFL hydro = 0.011207168710961585 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011207168710961585 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7344e+04 |  512 |      1 | 2.952e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1366.1842169675358 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.589575359761117, dt = 0.011207168710961585 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.27 us    (0.7%)
   patch tree reduce : 1745.00 ns (0.3%)
   gen split merge   : 716.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 1074.00 ns (0.2%)
   LB compute        : 567.29 us  (97.1%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (0.5%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.11 us    (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1797203838814774e-17,-6.698645544506166e-17,-2.5904083565675418e-17)
    sum a = (-5.965052670559023e-17,-4.73395736673432e-17,3.4782723576376464e-17)
    sum e = 2.5920015947914634
    sum de = -3.2864878353466853e-19
Info: CFL hydro = 0.01120672953833802 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01120672953833802 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7536e+04 |  512 |      1 | 2.920e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1381.8789869326324 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.600782528472077, dt = 0.01120672953833802 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.2%)
   patch tree reduce : 2.01 us    (0.6%)
   gen split merge   : 693.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 999.00 ns  (0.3%)
   LB compute        : 325.29 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.35 us    (70.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0479898199244885e-17,-6.814348889848387e-17,-2.5211766268434798e-17)
    sum a = (8.673725800101284e-17,3.270906494875353e-17,2.3049921346607326e-17)
    sum e = 2.592001595764204
    sum de = -4.2182240773264157e-19
Info: CFL hydro = 0.011201841123476724 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011201841123476724 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9565e+04 |  512 |      1 | 2.617e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1541.63773550709 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 23.611989258010414, dt = 0.011201841123476724 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.5%)
   patch tree reduce : 1138.00 ns (0.4%)
   gen split merge   : 772.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 931.00 ns  (0.3%)
   LB compute        : 275.02 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1911.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.232705344050844e-17,-6.752435524788602e-17,-2.484584803522094e-17)
    sum a = (2.9008533856261784e-17,2.652468088920612e-17,-1.0680128656459509e-16)
    sum e = 2.592001596229879
    sum de = 1.094366567852556e-18
Info: CFL hydro = 0.011197375863792913 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011197375863792913 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9667e+04 |  512 |      1 | 2.603e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1549.0194265320317 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.62319109913389, dt = 0.011197375863792913 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.11 us    (1.3%)
   patch tree reduce : 1728.00 ns (0.6%)
   gen split merge   : 1072.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1006.00 ns (0.3%)
   LB compute        : 289.88 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.14 us    (67.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2233378372805692e-17,-6.718990598272856e-17,-2.6837906896837183e-17)
    sum a = (6.69535228040724e-17,-6.05762998356213e-17,6.704207501651017e-17)
    sum e = 2.5920015962101597
    sum de = 3.595654861094505e-19
Info: CFL hydro = 0.01119341827509188 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01119341827509188 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9217e+04 |  512 |      1 | 2.664e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1513.0012962108672 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.634388474997685, dt = 0.01119341827509188 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.32 us    (1.3%)
   patch tree reduce : 1857.00 ns (0.6%)
   gen split merge   : 939.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 971.00 ns  (0.3%)
   LB compute        : 319.05 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.06 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.16 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3386752643895772e-17,-6.838060391360645e-17,-2.505808061048498e-17)
    sum a = (-7.249754995549557e-17,4.662530127610975e-18,9.114291352890769e-17)
    sum e = 2.5920015957303173
    sum de = -4.1186977060240354e-19
Info: CFL hydro = 0.011190045356506428 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011190045356506428 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9464e+04 |  512 |      1 | 2.630e-02 | 0.1% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.8953811260624 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.645581893272777, dt = 0.011190045356506428 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.3%)
   patch tree reduce : 1543.00 ns (0.5%)
   gen split merge   : 686.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 899.00 ns  (0.3%)
   LB compute        : 299.89 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.79 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1721092846306292e-17,-6.806445056010967e-17,-2.4030582211620466e-17)
    sum a = (1.7732397581543544e-18,-2.663884737796884e-19,-4.922624807779385e-17)
    sum e = 2.5920015948480635
    sum de = -5.603122946087197e-19
Info: CFL hydro = 0.011187324987459734 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011187324987459734 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9610e+04 |  512 |      1 | 2.611e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.9245580367947 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.656771938629284, dt = 0.011187324987459734 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.97 us    (1.4%)
   patch tree reduce : 1210.00 ns (0.4%)
   gen split merge   : 905.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1255.00 ns (0.4%)
   LB compute        : 276.92 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.62 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1902.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.2130921267505813e-17,-6.810323789283034e-17,-2.5224939324830497e-17)
    sum a = (-1.3000782091501795e-16,-5.2007226650219176e-17,2.4566286505045554e-17)
    sum e = 2.5920015936490515
    sum de = 4.87890977618477e-19
Info: CFL hydro = 0.011185314766204149 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011185314766204149 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9130e+04 |  512 |      1 | 2.676e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1504.7920372839699 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.667959263616744, dt = 0.011185314766204149 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.70 us    (1.6%)
   patch tree reduce : 1424.00 ns (0.5%)
   gen split merge   : 765.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1124.00 ns (0.4%)
   LB compute        : 279.88 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.19 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1928.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.958830635148352e-18,-6.89865645078086e-17,-2.458677792610553e-17)
    sum a = (-1.2726636151177972e-17,2.423403274928737e-17,3.270357617525532e-17)
    sum e = 2.592001592239334
    sum de = 5.344777897174635e-19
Info: CFL hydro = 0.011184060803750876 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011184060803750876 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9223e+04 |  512 |      1 | 2.663e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1511.838540755864 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 23.67914457838295, dt = 0.011184060803750876 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.40 us    (1.6%)
   patch tree reduce : 1185.00 ns (0.3%)
   gen split merge   : 774.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1063.00 ns (0.3%)
   LB compute        : 321.63 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (71.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0523808387230549e-17,-6.824887334964946e-17,-2.417987685077172e-17)
    sum a = (8.187200917220138e-17,-7.345003511655124e-17,3.634190116810071e-17)
    sum e = 2.5920015907382363
    sum de = -4.3029273720518457e-19
Info: CFL hydro = 0.011183597183201712 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011183597183201712 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9133e+04 |  512 |      1 | 2.676e-02 | 0.0% |   2.0% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1504.6120269988596 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.6903286391867, dt = 0.011183597183201712 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1557.00 ns (0.5%)
   gen split merge   : 701.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 949.00 ns  (0.3%)
   LB compute        : 283.09 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1842.00 ns (65.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1937716440368895e-17,-6.983915399119689e-17,-2.3767121083706488e-17)
    sum a = (1.2721659663206264e-16,1.1036386648316521e-16,-2.5393261712108872e-17)
    sum e = 2.5920015892686754
    sum de = -3.5405977195229754e-19
Info: CFL hydro = 0.01118394509838855 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01118394509838855 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9086e+04 |  512 |      1 | 2.683e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1500.8030694808892 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.7015122363699, dt = 0.01118394509838855 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.85 us    (1.7%)
   patch tree reduce : 1479.00 ns (0.5%)
   gen split merge   : 629.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1160.00 ns (0.4%)
   LB compute        : 274.10 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.09 us    (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.486328125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.3556538704107001e-17,-6.739335652039546e-17,-2.431453476059442e-17)
    sum a = (-1.9783881564233718e-16,6.844866470498423e-17,5.908554895350803e-17)
    sum e = 2.5920015879489924
    sum de = 2.761327408049019e-19
Info: CFL hydro = 0.011185112577567616 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011185112577567616 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9303e+04 |  512 |      1 | 2.652e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1517.8984730836498 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.71269618146829, dt = 0.011185112577567616 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.5%)
   patch tree reduce : 1751.00 ns (0.6%)
   gen split merge   : 712.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1022.00 ns (0.4%)
   LB compute        : 274.69 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (65.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.595839747800206e-18,-6.678520041679403e-17,-2.319043394816145e-17)
    sum a = (6.740506590385831e-17,3.901420202526151e-17,2.7777584919730366e-17)
    sum e = 2.59200158688406
    sum de = 4.3029273720518457e-19
Info: CFL hydro = 0.01118709409847824 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01118709409847824 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9372e+04 |  512 |      1 | 2.643e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1523.4857104843834 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.723881294045857, dt = 0.01118709409847824 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.44 us    (1.5%)
   patch tree reduce : 1427.00 ns (0.5%)
   gen split merge   : 695.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1023.00 ns (0.3%)
   LB compute        : 283.22 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1697674079380604e-17,-6.656930865919786e-17,-2.301040217742023e-17)
    sum a = (-2.4478466129074228e-17,-3.748466381042759e-18,-6.779733024986356e-17)
    sum e = 2.5920015861580086
    sum de = 6.505213034913027e-19
Info: CFL hydro = 0.011189870750197131 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011189870750197131 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9567e+04 |  512 |      1 | 2.617e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1539.1092292626279 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.735068388144335, dt = 0.011189870750197131 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.3%)
   patch tree reduce : 1210.00 ns (0.4%)
   gen split merge   : 756.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1050.00 ns (0.3%)
   LB compute        : 305.71 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.48 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1053657988924215e-17,-6.67895914355926e-17,-2.4460902053879962e-17)
    sum a = (-6.073071733003754e-17,-3.607368310315495e-17,-8.89913143176102e-17)
    sum e = 2.5920015858287924
    sum de = 2.981555974335137e-19
Info: CFL hydro = 0.011193410266503815 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011193410266503815 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9661e+04 |  512 |      1 | 2.604e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1546.9341652831565 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.74625825889453, dt = 0.011193410266503815 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.49 us    (1.5%)
   patch tree reduce : 1599.00 ns (0.5%)
   gen split merge   : 698.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 947.00 ns  (0.3%)
   LB compute        : 280.41 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1924.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0075924469776787e-17,-6.761949398852163e-17,-2.5568902464051524e-17)
    sum a = (-3.164460880833442e-17,4.811239297589087e-17,9.43542119435925e-17)
    sum e = 2.592001585924402
    sum de = -1.1519648082658485e-18
Info: CFL hydro = 0.01119766768687249 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01119766768687249 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9457e+04 |  512 |      1 | 2.631e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.3670218112172 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.757451669161036, dt = 0.01119766768687249 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.59 us    (1.5%)
   patch tree reduce : 1860.00 ns (0.6%)
   gen split merge   : 779.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1027.00 ns (0.3%)
   LB compute        : 284.19 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1959.00 ns (64.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.922238811826966e-18,-6.656345396746643e-17,-2.339827550462692e-17)
    sum a = (-1.996449880414808e-18,-7.2926040206589e-17,-2.860602379972654e-17)
    sum e = 2.5920015864414383
    sum de = -5.522654816098038e-19
Info: CFL hydro = 0.011202586009891298 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011202586009891298 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8853e+04 |  512 |      1 | 2.716e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1484.3327445115738 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.768649336847908, dt = 0.011202586009891298 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.5%)
   patch tree reduce : 1635.00 ns (0.6%)
   gen split merge   : 739.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 957.00 ns  (0.3%)
   LB compute        : 275.23 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.478515625
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0200336669069499e-17,-6.804469097551613e-17,-2.4386254734304335e-17)
    sum a = (-9.880377765947301e-17,-1.3299956838977445e-16,5.405051406448536e-17)
    sum e = 2.5920015873458744
    sum de = -1.009663273127126e-18
Info: CFL hydro = 0.011208096943196638 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011208096943196638 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9489e+04 |  512 |      1 | 2.627e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1535.1132870805263 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.779851922857798, dt = 0.011208096943196638 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.50 us    (1.5%)
   patch tree reduce : 1862.00 ns (0.6%)
   gen split merge   : 822.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 909.00 ns  (0.3%)
   LB compute        : 275.66 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1940.00 ns (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.416119363918728e-18,-6.98289082806669e-17,-2.3405593869291197e-17)
    sum a = (-5.443106902702777e-17,-1.3129146207713216e-17,1.5369151264155168e-16)
    sum e = 2.5920015885759367
    sum de = 5.319366908757006e-19
Info: CFL hydro = 0.011214122272389677 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011214122272389677 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9505e+04 |  512 |      1 | 2.625e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1537.1336852411782 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.791060019800994, dt = 0.011214122272389677 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.75 us    (0.8%)
   patch tree reduce : 1446.00 ns (0.3%)
   gen split merge   : 700.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 907.00 ns  (0.2%)
   LB compute        : 456.83 us  (96.5%)
   LB move op cnt    : 0
   LB apply          : 3.51 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.64 us    (71.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.132166814944775e-18,-6.943225291586308e-17,-2.1094454308312473e-17)
    sum a = (1.0277911334510837e-16,9.707371625283789e-17,1.2675407598528032e-17)
    sum e = 2.5920015900475293
    sum de = 2.0261028098322864e-18
Info: CFL hydro = 0.011217453596012 sink sink = inf                                   [SPH][rank=0]
Info: cfl dt = 0.011217453596012 cfl multiplier : 0.9999999999999997           [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8280e+04 |  512 |      1 | 2.801e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1441.3907163874408 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.802274142073383, dt = 0.011217453596012 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1375.00 ns (0.5%)
   gen split merge   : 680.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 916.00 ns  (0.3%)
   LB compute        : 275.69 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.86 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1883.00 ns (63.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0113979966031028e-17,-6.761656664265591e-17,-2.1663823079193235e-17)
    sum a = (6.731139083615556e-17,-3.6274206294956144e-17,-2.634611279139776e-19)
    sum e = 2.5920015916423402
    sum de = 3.1170812458958252e-19
Info: CFL hydro = 0.011214091226675554 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011214091226675554 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8888e+04 |  512 |      1 | 2.711e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1489.7313487004387 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.813491595669394, dt = 0.011214091226675554 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.79 us    (1.5%)
   patch tree reduce : 1433.00 ns (0.5%)
   gen split merge   : 839.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 902.00 ns  (0.3%)
   LB compute        : 296.24 us  (94.0%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.092046375203437e-17,-6.870627114116678e-17,-2.171944265064174e-17)
    sum a = (6.270374844352666e-18,-2.984648661032152e-17,-5.755161971987555e-18)
    sum e = 2.59200159322513
    sum de = -1.1350241493207625e-18
Info: CFL hydro = 0.01121139460574846 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01121139460574846 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8844e+04 |  512 |      1 | 2.717e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1485.8549644025825 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.82470568689607, dt = 0.01121139460574846 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 1592.00 ns (0.5%)
   gen split merge   : 845.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1207.00 ns (0.4%)
   LB compute        : 284.79 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1989.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.05779642857462e-17,-6.904877060745495e-17,-2.2020959274809958e-17)
    sum a = (5.276248188357257e-17,-4.7117644258898996e-17,-1.2625642718810948e-16)
    sum e = 2.5920015947279347
    sum de = -8.843023969334896e-19
Info: CFL hydro = 0.011209388646369032 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011209388646369032 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9019e+04 |  512 |      1 | 2.692e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1499.2358800678194 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.83591708150182, dt = 0.011209388646369032 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.04 us    (1.4%)
   patch tree reduce : 1421.00 ns (0.5%)
   gen split merge   : 802.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 901.00 ns  (0.3%)
   LB compute        : 276.36 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.05 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.95 us    (69.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1508860271042253e-17,-6.957935204561505e-17,-2.4036436903351888e-17)
    sum a = (-1.7871446510164813e-17,-3.593902519333225e-17,-8.005705473546065e-17)
    sum e = 2.5920015960532448
    sum de = -1.0232158002831948e-18
Info: CFL hydro = 0.011208092125266349 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011208092125266349 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9367e+04 |  512 |      1 | 2.644e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1526.4441337136202 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.847126470148186, dt = 0.011208092125266349 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.64 us    (1.6%)
   patch tree reduce : 1218.00 ns (0.4%)
   gen split merge   : 1017.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 910.00 ns  (0.3%)
   LB compute        : 278.01 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1914.00 ns (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.0921927424967225e-17,-7.042974601960405e-17,-2.4703871760733965e-17)
    sum a = (-9.563346208690815e-17,5.927582643477924e-17,1.0796051552741658e-17)
    sum e = 2.592001597119583
    sum de = 1.7804632551285393e-18
Info: CFL hydro = 0.011207517221463858 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011207517221463858 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9206e+04 |  512 |      1 | 2.666e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1513.5724853443398 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.858334562273452, dt = 0.011207517221463858 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.60 us    (1.6%)
   patch tree reduce : 1606.00 ns (0.6%)
   gen split merge   : 761.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 930.00 ns  (0.3%)
   LB compute        : 274.38 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.12 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1830.00 ns (64.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.408489612394711e-18,-6.883361068632521e-17,-2.403204588455332e-17)
    sum a = (-9.511824921454304e-17,5.111731350704307e-17,5.306399850774079e-17)
    sum e = 2.59200159786731
    sum de = 1.2654672231979247e-18
Info: CFL hydro = 0.011207669403485273 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011207669403485273 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8750e+04 |  512 |      1 | 2.731e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1477.5753825146226 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.869542079494916, dt = 0.011207669403485273 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.2%)
   patch tree reduce : 1286.00 ns (0.4%)
   gen split merge   : 660.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1244.00 ns (0.4%)
   LB compute        : 317.30 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 2.77 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.13363048787763e-18,-6.833083903388937e-17,-2.3004547485688808e-17)
    sum a = (2.8383545513932515e-17,-3.477979623051075e-17,9.217626661950363e-17)
    sum e = 2.5920015982624993
    sum de = 6.2680438096818225e-19
Info: CFL hydro = 0.011208548235335508 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011208548235335508 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9661e+04 |  512 |      1 | 2.604e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1549.3351692172748 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.880749748898403, dt = 0.011208548235335508 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.07 us    (1.4%)
   patch tree reduce : 1883.00 ns (0.7%)
   gen split merge   : 702.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 873.00 ns  (0.3%)
   LB compute        : 272.49 us  (94.1%)
   LB move op cnt    : 0
   LB apply          : 2.76 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1980.00 ns (64.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (9.285541086034855e-18,-6.905462529918638e-17,-2.1881910346188692e-17)
    sum a = (-7.476294973732256e-17,-1.1433920216880057e-16,-2.621145488157506e-17)
    sum e = 2.5920015982989333
    sum de = 1.0232158002831948e-18
Info: CFL hydro = 0.011210146093140878 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011210146093140878 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8949e+04 |  512 |      1 | 2.702e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1493.389726764063 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 23.891958297133737, dt = 0.011210146093140878 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.33 us    (1.4%)
   patch tree reduce : 1401.00 ns (0.4%)
   gen split merge   : 693.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 944.00 ns  (0.3%)
   LB compute        : 300.00 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.88 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.750148179469507e-18,-7.11440184108375e-17,-2.2792314910424772e-17)
    sum a = (-1.7156149547878362e-16,-5.810781543436062e-17,2.0525231904724995e-16)
    sum e = 2.5920015979975033
    sum de = -3.049318610115481e-20
Info: CFL hydro = 0.011212448577491724 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011212448577491724 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9278e+04 |  512 |      1 | 2.656e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1519.5335012861292 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.90316844322688, dt = 0.011212448577491724 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.4%)
   patch tree reduce : 1280.00 ns (0.4%)
   gen split merge   : 707.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 863.00 ns  (0.3%)
   LB compute        : 302.88 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.17 us    (69.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.245803791353865e-18,-7.124354817027167e-17,-1.9308773330228844e-17)
    sum a = (-1.8196381901258717e-17,-1.535685641151918e-17,-8.542031827967617e-17)
    sum e = 2.5920015974037107
    sum de = -3.1255515753683683e-19
Info: CFL hydro = 0.011215435082758097 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011215435082758097 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8821e+04 |  512 |      1 | 2.720e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1483.7690354111737 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.91438089180437, dt = 0.011215435082758097 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.99 us    (1.4%)
   patch tree reduce : 1321.00 ns (0.5%)
   gen split merge   : 630.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1696.00 ns (0.6%)
   LB compute        : 277.03 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.15 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (64.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.9439757803259055e-18,-7.107303027359402e-17,-2.1928747880040068e-17)
    sum a = (-1.231549042433888e-16,-4.8113856648823726e-17,5.998204862488199e-17)
    sum e = 2.5920015965841476
    sum de = 6.185458097324528e-19
Info: CFL hydro = 0.011219079131637317 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011219079131637317 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9507e+04 |  512 |      1 | 2.625e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1538.3220381602582 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.925596326887128, dt = 0.011219079131637317 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.01 us    (1.4%)
   patch tree reduce : 1206.00 ns (0.4%)
   gen split merge   : 980.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1185.00 ns (0.4%)
   LB compute        : 276.55 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.95 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.893370001395446e-18,-7.194025648631086e-17,-2.04958120787746e-17)
    sum a = (-7.484491542156246e-17,5.5338546245398136e-17,-9.84656692119834e-17)
    sum e = 2.59200159562078
    sum de = 6.439567981500818e-19
Info: CFL hydro = 0.011223348904060812 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011223348904060812 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9498e+04 |  512 |      1 | 2.626e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1538.0739341405813 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.936815406018766, dt = 0.011223348904060812 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.4%)
   patch tree reduce : 1150.00 ns (0.4%)
   gen split merge   : 703.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1400.00 ns (0.5%)
   LB compute        : 290.38 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.98 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.15 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.49817830952448e-18,-7.064197859486809e-17,-2.2386877508023816e-17)
    sum a = (7.514204102693211e-17,6.58652819784944e-17,9.736937818527469e-17)
    sum e = 2.5920015946039836
    sum de = -4.137755947337257e-19
Info: CFL hydro = 0.011228207811778128 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011228207811778128 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9802e+04 |  512 |      1 | 2.586e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1562.682798790981 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 23.948038754922827, dt = 0.011228207811778128 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.2%)
   patch tree reduce : 1248.00 ns (0.4%)
   gen split merge   : 696.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1547.00 ns (0.5%)
   LB compute        : 323.06 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.27 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.1492013777854064e-18,-6.988233234271612e-17,-2.015623995835214e-17)
    sum a = (-1.1674255312454917e-16,-8.848781082870793e-17,5.02625285142555e-18)
    sum e = 2.592001593624923
    sum de = -7.555533889508359e-19
Info: CFL hydro = 0.011233614680937545 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011233614680937545 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9430e+04 |  512 |      1 | 2.635e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.9373339786575 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.959266962734606, dt = 0.011233614680937545 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.79 us    (1.6%)
   patch tree reduce : 1217.00 ns (0.4%)
   gen split merge   : 762.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 989.00 ns  (0.3%)
   LB compute        : 279.17 us  (90.6%)
   LB move op cnt    : 0
   LB apply          : 3.01 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (66.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.7839059182910297e-18,-7.171045983585255e-17,-2.0807574413472807e-17)
    sum a = (8.343521186449099e-17,2.7581452746727742e-17,-5.348260896653745e-17)
    sum e = 2.5920015927688453
    sum de = -1.2841019480375193e-18
Info: CFL hydro = 0.011239503874309791 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011239503874309791 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9557e+04 |  512 |      1 | 2.618e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1544.7539556351646 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.970500577415542, dt = 0.011239503874309791 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.42 us    (1.5%)
   patch tree reduce : 1612.00 ns (0.6%)
   gen split merge   : 718.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 856.00 ns  (0.3%)
   LB compute        : 276.61 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1840.00 ns (64.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.723272554324476e-18,-7.062295084674097e-17,-2.166528675212609e-17)
    sum a = (1.6595123712714875e-16,-5.94251210739305e-17,8.401482634590174e-17)
    sum e = 2.592001592108492
    sum de = -3.5575383784680614e-20
Info: CFL hydro = 0.011238718389391245 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011238718389391245 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8592e+04 |  512 |      1 | 2.754e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1469.2496429572032 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.981740081289853, dt = 0.011238718389391245 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.21 us    (1.4%)
   patch tree reduce : 1447.00 ns (0.5%)
   gen split merge   : 1022.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 922.00 ns  (0.3%)
   LB compute        : 281.34 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.38 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (68.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.019775385974646e-18,-7.191537404645231e-17,-1.9616144646128485e-17)
    sum a = (-6.572476937694027e-17,-5.644508298263684e-17,1.6147825264434257e-16)
    sum e = 2.5920015916598387
    sum de = -8.182338270476541e-19
Info: CFL hydro = 0.01123690016688989 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01123690016688989 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 2.0104e+04 |  512 |      1 | 2.547e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1588.6994323477652 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 23.992978799679246, dt = 0.007021200320753707 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.6%)
   patch tree reduce : 1261.00 ns (0.4%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 968.00 ns  (0.3%)
   LB compute        : 281.32 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.42 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (65.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.327769475593769e-18,-7.221176781535554e-17,-1.8257856164438646e-17)
    sum a = (4.6228645911305934e-17,-6.428451521101052e-17,4.618180837745456e-17)
    sum e = 2.5920015730091843
    sum de = -2.490276864927643e-19
Info: CFL hydro = 0.011236167166431409 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011236167166431409 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8766e+04 |  512 |      1 | 2.728e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 926.4185119316228 (tsim/hr)                             [sph::Model][rank=0]
Info: iteration since start : 2518                                                    [SPH][rank=0]
Info: time since start : 1831.3553205350001 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14991625582943635 max=0.15008264530223744 delta=0.00016638947280109284
Number of particle pairs: 130816
Distance min=0.124446 max=1.838153 mean=0.800692
---------------- t = 24, dt = 0.011236167166431409 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 9.87 us    (1.8%)
   patch tree reduce : 1055.00 ns (0.2%)
   gen split merge   : 685.00 ns  (0.1%)
   split / merge op  : 0/0
   apply split merge : 1185.00 ns (0.2%)
   LB compute        : 524.50 us  (95.5%)
   LB move op cnt    : 0
   LB apply          : 4.56 us    (0.8%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.68 us    (82.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.323067069935462e-18,-7.307240749987454e-17,-1.7982685653061824e-17)
    sum a = (6.718258761806428e-17,1.0020304898328281e-16,-9.420784465030696e-17)
    sum e = 2.592001591373287
    sum de = 7.420008617947671e-19
Info: CFL hydro = 0.01123501918409321 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01123501918409321 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7034e+04 |  512 |      1 | 3.006e-02 | 0.1% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1345.7804752265865 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.01123616716643, dt = 0.01123501918409321 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.41 us    (1.5%)
   patch tree reduce : 1347.00 ns (0.5%)
   gen split merge   : 673.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 910.00 ns  (0.3%)
   LB compute        : 277.35 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1910.00 ns (65.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (7.122232491274527e-18,-7.107888496532544e-17,-1.9930834326692403e-17)
    sum a = (1.3421880794284303e-16,3.5889260313615164e-18,2.1861418925128717e-17)
    sum e = 2.5920015917293444
    sum de = 7.691059161069047e-19
Info: CFL hydro = 0.011234542160010363 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011234542160010363 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9455e+04 |  512 |      1 | 2.632e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.8618245077312 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.022471186350522, dt = 0.011234542160010363 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.5%)
   patch tree reduce : 1457.00 ns (0.5%)
   gen split merge   : 1031.00 ns (0.3%)
   split / merge op  : 0/0
   apply split merge : 1022.00 ns (0.3%)
   LB compute        : 294.01 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (67.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.697144567026971e-18,-7.143309381507646e-17,-1.9081904025636255e-17)
    sum a = (-1.773034843943755e-16,1.0129787633705867e-16,4.02919884956443e-17)
    sum e = 2.592001592271423
    sum de = 3.6253010142484055e-19
Info: CFL hydro = 0.011234594104107069 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011234594104107069 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9582e+04 |  512 |      1 | 2.615e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1546.8740872517253 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.033705728510533, dt = 0.011234594104107069 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.43 us    (1.1%)
   patch tree reduce : 1055.00 ns (0.3%)
   gen split merge   : 751.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 903.00 ns  (0.2%)
   LB compute        : 384.25 us  (96.0%)
   LB move op cnt    : 0
   LB apply          : 2.83 us    (0.7%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.21 us    (65.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.250194810152431e-18,-6.995185680702676e-17,-1.8515462600621203e-17)
    sum a = (-1.990595188683386e-18,2.7148205558602534e-17,-8.142705260061334e-17)
    sum e = 2.592001593017319
    sum de = 5.251604272976662e-20
Info: CFL hydro = 0.011235174901823412 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011235174901823412 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9177e+04 |  512 |      1 | 2.670e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1514.8399365720893 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.04494032261464, dt = 0.011235174901823412 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 5.21 us    (1.8%)
   patch tree reduce : 1349.00 ns (0.5%)
   gen split merge   : 687.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 969.00 ns  (0.3%)
   LB compute        : 278.00 us  (93.9%)
   LB move op cnt    : 0
   LB apply          : 3.67 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.22 us    (66.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.470703125
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.983494949513002e-18,-7.012310654017084e-17,-1.9955716766550946e-17)
    sum a = (-3.666207962216284e-17,1.731290891898718e-16,-4.27977965566928e-17)
    sum e = 2.592001593899475
    sum de = -1.5534584252643868e-18
Info: CFL hydro = 0.0112360475832813 sink sink = inf                                  [SPH][rank=0]
Info: cfl dt = 0.0112360475832813 cfl multiplier : 0.9999999999999997          [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8376e+04 |  512 |      1 | 2.786e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1451.688592576486 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 24.056175497516463, dt = 0.0112360475832813 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.57 us    (1.4%)
   patch tree reduce : 1254.00 ns (0.4%)
   gen split merge   : 739.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 898.00 ns  (0.3%)
   LB compute        : 299.52 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.21 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.491700844073577e-18,-6.71357500842129e-17,-2.020746851100208e-17)
    sum a = (-6.319554254896609e-17,3.1837813635471333e-17,-1.8629629089383926e-17)
    sum e = 2.5920015948418746
    sum de = -1.5585406229479126e-19
Info: CFL hydro = 0.011234308260088954 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011234308260088954 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9379e+04 |  512 |      1 | 2.642e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1531.0420550603944 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.067411545099745, dt = 0.011234308260088954 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.3%)
   patch tree reduce : 1586.00 ns (0.5%)
   gen split merge   : 657.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 939.00 ns  (0.3%)
   LB compute        : 328.38 us  (95.2%)
   LB move op cnt    : 0
   LB apply          : 3.32 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.42 us    (69.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.581296279837499e-18,-6.765974499417516e-17,-2.047092963891606e-17)
    sum a = (-1.0073582593084218e-16,-8.938943335534688e-17,7.009236940858087e-17)
    sum e = 2.592001595750824
    sum de = 1.412850956020173e-18
Info: CFL hydro = 0.01123330103875865 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01123330103875865 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9353e+04 |  512 |      1 | 2.646e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.7382281995006 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.078645853359834, dt = 0.01123330103875865 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.67 us    (1.3%)
   patch tree reduce : 1181.00 ns (0.4%)
   gen split merge   : 745.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 706.00 ns  (0.2%)
   LB compute        : 273.53 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.73 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1873.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.184952301893418e-18,-6.937077865268315e-17,-1.8904799600760745e-17)
    sum a = (2.825474229584124e-17,-2.0343297359171064e-16,-1.7290075621234636e-16)
    sum e = 2.5920015965721603
    sum de = -8.673617379884035e-19
Info: CFL hydro = 0.011233025490037282 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011233025490037282 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9759e+04 |  512 |      1 | 2.591e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1560.6711792807703 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.08987915439859, dt = 0.011233025490037282 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.58 us    (1.2%)
   patch tree reduce : 1457.00 ns (0.5%)
   gen split merge   : 964.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 620.00 ns  (0.2%)
   LB compute        : 274.86 us  (91.1%)
   LB move op cnt    : 0
   LB apply          : 14.81 us   (4.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.03 us    (68.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.402728182029136e-18,-7.221030414242269e-17,-2.224782857940255e-17)
    sum a = (-1.4595746486434358e-16,-1.4856280268482625e-16,1.7716297179282136e-17)
    sum e = 2.592001597244647
    sum de = 1.8041801776516597e-18
Info: CFL hydro = 0.011233469753876294 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011233469753876294 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9518e+04 |  512 |      1 | 2.623e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1541.5898238610723 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.101112179888627, dt = 0.011233469753876294 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.63 us    (1.4%)
   patch tree reduce : 1302.00 ns (0.4%)
   gen split merge   : 759.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1105.00 ns (0.3%)
   LB compute        : 323.31 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.62 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.52 us    (71.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7271340607694085e-18,-7.38027802933694e-17,-2.098906985714688e-17)
    sum a = (-5.342406204922323e-17,1.2387356765342083e-16,8.278534108230317e-18)
    sum e = 2.5920015977225703
    sum de = -6.2002811739014785e-19
Info: CFL hydro = 0.011233332537065256 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011233332537065256 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.7923e+04 |  512 |      1 | 2.857e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1415.6565340386228 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.112345649642503, dt = 0.011233332537065256 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.52 us    (1.5%)
   patch tree reduce : 1144.00 ns (0.4%)
   gen split merge   : 620.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1150.00 ns (0.4%)
   LB compute        : 279.22 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.10 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1934.00 ns (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.4197627448697681e-18,-7.085640667953141e-17,-2.095101436089264e-17)
    sum a = (-1.0047821949465962e-16,8.267995663113758e-17,1.5757317325948428e-16)
    sum e = 2.5920015979719224
    sum de = 3.218725199566341e-20
Info: CFL hydro = 0.01123163759371918 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01123163759371918 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9627e+04 |  512 |      1 | 2.609e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1550.1980789669162 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.123578982179566, dt = 0.01123163759371918 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.35 us    (1.4%)
   patch tree reduce : 1532.00 ns (0.5%)
   gen split merge   : 644.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 890.00 ns  (0.3%)
   LB compute        : 298.48 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 2.93 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1932.00 ns (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.466796875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.834823084081229e-19,-7.003674983713238e-17,-1.833103981108142e-17)
    sum a = (-2.8822647393789145e-17,-1.5302993247590102e-16,-1.9179970112137567e-17)
    sum e = 2.5920015979824553
    sum de = -5.98005260761536e-19
Info: CFL hydro = 0.01123006344397368 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01123006344397368 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9362e+04 |  512 |      1 | 2.644e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1529.04155375699 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 24.134810619773287, dt = 0.01123006344397368 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.49 us    (1.5%)
   patch tree reduce : 1741.00 ns (0.6%)
   gen split merge   : 612.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 812.00 ns  (0.3%)
   LB compute        : 274.82 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.08 us    (66.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.844227895397843e-19,-7.317925562397299e-17,-1.9548815691217138e-17)
    sum a = (7.913786813362744e-17,9.576811999673084e-17,6.955373776929008e-17)
    sum e = 2.5920015977819477
    sum de = 1.9397054492123478e-19
Info: CFL hydro = 0.011228639295757948 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011228639295757948 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9338e+04 |  512 |      1 | 2.648e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1526.9877507140195 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.14604068321726, dt = 0.011228639295757948 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1242.00 ns (0.4%)
   gen split merge   : 1049.00 ns (0.4%)
   split / merge op  : 0/0
   apply split merge : 788.00 ns  (0.3%)
   LB compute        : 274.97 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 3.42 us    (1.2%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.53 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8969201209806384e-18,-7.083298791260572e-17,-1.8348603886275682e-17)
    sum a = (4.435514455725098e-17,-4.120239305988038e-17,-7.834163005815408e-17)
    sum e = 2.5920015974086508
    sum de = 6.844026213814747e-19
Info: CFL hydro = 0.011226982217123179 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011226982217123179 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9587e+04 |  512 |      1 | 2.614e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1546.435487762104 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 24.15726932251302, dt = 0.011226982217123179 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.96 us    (1.6%)
   patch tree reduce : 1338.00 ns (0.4%)
   gen split merge   : 714.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 798.00 ns  (0.3%)
   LB compute        : 299.27 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (67.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8822833916520843e-18,-7.199807156715864e-17,-1.9955716766550946e-17)
    sum a = (1.8908897884972742e-16,-1.7166834360288207e-16,-1.535100171978776e-17)
    sum e = 2.592001596914795
    sum de = 1.1519648082658485e-18
Info: CFL hydro = 0.011225045426706973 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011225045426706973 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9122e+04 |  512 |      1 | 2.678e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1509.482871426734 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 24.168496304730144, dt = 0.011225045426706973 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.3%)
   patch tree reduce : 1440.00 ns (0.4%)
   gen split merge   : 755.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 877.00 ns  (0.3%)
   LB compute        : 314.81 us  (95.1%)
   LB move op cnt    : 0
   LB apply          : 2.96 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (69.9%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.947214513051357e-18,-7.447021515075147e-17,-1.9818131510862535e-17)
    sum a = (5.1129022890505915e-17,-2.611748707928574e-16,3.346541793680657e-17)
    sum e = 2.5920015963667384
    sum de = 1.8804131429045468e-19
Info: CFL hydro = 0.011223305257267321 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011223305257267321 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9351e+04 |  512 |      1 | 2.646e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1527.292159608645 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 24.17972135015685, dt = 0.011223305257267321 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.81 us    (1.5%)
   patch tree reduce : 1282.00 ns (0.4%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 903.00 ns  (0.3%)
   LB compute        : 311.57 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.16 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.41 us    (70.6%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.809629257362946e-18,-7.796692978734309e-17,-1.9103859119629085e-17)
    sum a = (-1.1221687641616019e-16,-8.328445355240688e-17,-1.0768534501603977e-16)
    sum e = 2.5920015958394313
    sum de = 5.000670762352576e-19
Info: CFL hydro = 0.011221784400688712 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011221784400688712 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9804e+04 |  512 |      1 | 2.585e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1562.7928934195074 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.190944655414118, dt = 0.011221784400688712 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.5%)
   patch tree reduce : 1501.00 ns (0.5%)
   gen split merge   : 816.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1068.00 ns (0.4%)
   LB compute        : 276.73 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.61 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1853.00 ns (65.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.474609375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.4940986775856545e-18,-7.788350043017033e-17,-2.0933450285698374e-17)
    sum a = (-1.0594650157180751e-16,4.274656800404286e-17,-8.4518329834804e-17)
    sum e = 2.5920015954046867
    sum de = 2.5199230180815435e-19
Info: CFL hydro = 0.01122050441051999 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01122050441051999 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9458e+04 |  512 |      1 | 2.631e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1535.295846424877 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 24.202166439814807, dt = 0.01122050441051999 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.17 us    (1.4%)
   patch tree reduce : 1252.00 ns (0.4%)
   gen split merge   : 706.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 958.00 ns  (0.3%)
   LB compute        : 291.24 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 3.28 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.1416648876272361e-18,-7.659839559512327e-17,-2.1999004180817128e-17)
    sum a = (9.379508888324173e-17,-1.2199274793470161e-16,2.93495696496171e-17)
    sum e = 2.5920015951271744
    sum de = 9.774760211314626e-19
Info: CFL hydro = 0.011219485562448879 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011219485562448879 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9250e+04 |  512 |      1 | 2.660e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1518.7337370176122 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.213386944225327, dt = 0.011219485562448879 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.51 us    (1.5%)
   patch tree reduce : 1457.00 ns (0.5%)
   gen split merge   : 734.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 948.00 ns  (0.3%)
   LB compute        : 289.03 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.06 us    (66.3%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.4396313922102626e-18,-7.902809266366328e-17,-2.0895394789444133e-17)
    sum a = (-1.512735249564745e-16,-9.941266559954087e-18,7.203027237168147e-17)
    sum e = 2.5920015950588824
    sum de = 7.902817397882622e-19
Info: CFL hydro = 0.011218746433528378 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011218746433528378 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9624e+04 |  512 |      1 | 2.609e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1548.0930267812198 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.224606429787777, dt = 0.011218746433528378 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.37 us    (1.4%)
   patch tree reduce : 2.42 us    (0.8%)
   gen split merge   : 817.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 1597.00 ns (0.5%)
   LB compute        : 284.30 us  (93.8%)
   LB move op cnt    : 0
   LB apply          : 3.37 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.34 us    (68.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.312603233911581e-19,-7.854654426875384e-17,-1.9894242503371017e-17)
    sum a = (3.567263671955256e-17,1.8898213072562897e-17,8.18222442924843e-17)
    sum e = 2.5920015952341147
    sum de = -5.082197683525802e-19
Info: CFL hydro = 0.011218303755048533 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011218303755048533 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8649e+04 |  512 |      1 | 2.745e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1471.0500771539707 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.235825176221304, dt = 0.011218303755048533 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.55 us    (1.5%)
   patch tree reduce : 1339.00 ns (0.5%)
   gen split merge   : 736.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1181.00 ns (0.4%)
   LB compute        : 277.70 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1979.00 ns (66.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.946685000697723e-18,-7.808109627610581e-17,-1.901311139779205e-17)
    sum a = (4.1187756330551825e-18,-9.463070890856472e-17,3.665768860336427e-18)
    sum e = 2.5920015956666007
    sum de = 8.300922883092143e-20
Info: CFL hydro = 0.011218172234103903 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011218172234103903 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9183e+04 |  512 |      1 | 2.669e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1513.0956975109955 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.24704347997635, dt = 0.011218172234103903 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.90 us    (1.6%)
   patch tree reduce : 1356.00 ns (0.5%)
   gen split merge   : 719.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1226.00 ns (0.4%)
   LB compute        : 280.41 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 2.91 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1898.00 ns (67.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.6715144893209022e-18,-7.989165969404799e-17,-1.9475632044574365e-17)
    sum a = (1.2585464896804065e-16,6.145779685943348e-17,-4.5304336454207726e-17)
    sum e = 2.592001596347762
    sum de = 9.994988777600744e-20
Info: CFL hydro = 0.011218364282836839 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011218364282836839 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9445e+04 |  512 |      1 | 2.633e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.7898553445955 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.258261652210457, dt = 0.011218364282836839 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.59 us    (1.4%)
   patch tree reduce : 1467.00 ns (0.4%)
   gen split merge   : 731.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 980.00 ns  (0.3%)
   LB compute        : 311.17 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.22 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.18 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.890442655529736e-18,-7.841920472359542e-17,-2.0189904435807814e-17)
    sum a = (5.558956615338284e-17,4.1863607307297824e-17,-2.347145915126969e-17)
    sum e = 2.5920015972468926
    sum de = 7.284483346386983e-20
Info: CFL hydro = 0.011218889822122314 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011218889822122314 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8470e+04 |  512 |      1 | 2.772e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1456.8939514361589 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.269480016493294, dt = 0.011218889822122314 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.40 us    (1.5%)
   patch tree reduce : 1448.00 ns (0.5%)
   gen split merge   : 948.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 932.00 ns  (0.3%)
   LB compute        : 286.04 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.20 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1816.00 ns (65.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.998754452561037e-18,-7.806792321971012e-17,-2.027772481177914e-17)
    sum a = (-1.1628442349656542e-16,9.913749508816405e-17,2.4390645753102902e-17)
    sum e = 2.592001598313679
    sum de = 3.6761229910836635e-19
Info: CFL hydro = 0.011219756105424238 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011219756105424238 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9559e+04 |  512 |      1 | 2.618e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1542.907807164822 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 24.280698906315415, dt = 0.011219756105424238 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.38 us    (1.4%)
   patch tree reduce : 1309.00 ns (0.4%)
   gen split merge   : 752.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 941.00 ns  (0.3%)
   LB compute        : 303.91 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 3.14 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1960.00 ns (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.9583943841605665e-18,-7.632615242961216e-17,-1.9651272796517017e-17)
    sum a = (-1.0871430708783713e-16,4.332691432192004e-17,-1.4314721283326115e-16)
    sum e = 2.5920015994816032
    sum de = 1.6449379835678513e-18
Info: CFL hydro = 0.011220967656819788 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011220967656819788 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8868e+04 |  512 |      1 | 2.714e-02 | 0.1% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1488.504395333989 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 24.29191866242084, dt = 0.011220967656819788 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.5%)
   patch tree reduce : 1414.00 ns (0.5%)
   gen split merge   : 745.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 980.00 ns  (0.3%)
   LB compute        : 283.38 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.87 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1905.00 ns (66.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (8.020927672047761e-19,-7.622808634311085e-17,-2.2297593459119635e-17)
    sum a = (7.19600160709044e-17,-2.837110429400325e-17,-4.111750002977477e-17)
    sum e = 2.592001600673145
    sum de = -1.0045810754436002e-18
Info: CFL hydro = 0.011222525553595365 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011222525553595365 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9378e+04 |  512 |      1 | 2.642e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1528.879314582455 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 24.30313963007766, dt = 0.011222525553595365 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.84 us    (1.6%)
   patch tree reduce : 1789.00 ns (0.6%)
   gen split merge   : 715.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1210.00 ns (0.4%)
   LB compute        : 288.84 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 3.03 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (68.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.4092056474800394e-18,-7.715605498254119e-17,-2.2323939571911032e-17)
    sum a = (9.461474572564077e-17,-1.0084560140080633e-16,-7.467073834255267e-17)
    sum e = 2.592001601805846
    sum de = -2.0430434687773724e-18
Info: CFL hydro = 0.011224145057378154 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011224145057378154 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9223e+04 |  512 |      1 | 2.664e-02 | 0.1% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1516.8325185438391 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.314362155631255, dt = 0.011224145057378154 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.61 us    (1.5%)
   patch tree reduce : 1378.00 ns (0.5%)
   gen split merge   : 726.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1167.00 ns (0.4%)
   LB compute        : 282.07 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.33 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1981.00 ns (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.691383136661397e-18,-7.851434346423103e-17,-2.309090418872728e-17)
    sum a = (-7.515375041039495e-17,1.0120273759642306e-16,2.802055462658437e-17)
    sum e = 2.5920016027973984
    sum de = 1.2485265642528387e-18
Info: CFL hydro = 0.01122606523360864 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01122606523360864 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9033e+04 |  512 |      1 | 2.690e-02 | 0.0% |   1.9% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1502.0756953841485 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.325586300688634, dt = 0.01122606523360864 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.53 us    (1.5%)
   patch tree reduce : 1446.00 ns (0.5%)
   gen split merge   : 715.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 936.00 ns  (0.3%)
   LB compute        : 282.95 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.89 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1903.00 ns (64.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.098906985714688e-18,-7.638616301985923e-17,-2.2332721609508166e-17)
    sum a = (6.919660157367336e-17,5.0821651574606276e-17,-6.042627336000361e-17)
    sum e = 2.592001603577113
    sum de = -6.742382260144231e-19
Info: CFL hydro = 0.01122828880723032 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01122828880723032 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.8876e+04 |  512 |      1 | 2.712e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1489.9830303678136 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.336812365922242, dt = 0.01122828880723032 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.31 us    (1.3%)
   patch tree reduce : 1576.00 ns (0.5%)
   gen split merge   : 711.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 953.00 ns  (0.3%)
   LB compute        : 325.70 us  (95.0%)
   LB move op cnt    : 0
   LB apply          : 3.13 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.25 us    (69.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.553797880972986e-18,-7.624418674537225e-17,-2.3477313843001112e-17)
    sum a = (-8.237844000696937e-17,-5.4964577811053573e-17,3.875220457028039e-17)
    sum e = 2.592001604087282
    sum de = 5.251604272976662e-20
Info: CFL hydro = 0.011228475326168285 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011228475326168285 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9408e+04 |  512 |      1 | 2.638e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1532.24290918933 (tsim/hr)                              [sph::Model][rank=0]
---------------- t = 24.348040654729473, dt = 0.011228475326168285 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.14 us    (1.4%)
   patch tree reduce : 1465.00 ns (0.5%)
   gen split merge   : 677.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 935.00 ns  (0.3%)
   LB compute        : 273.39 us  (94.2%)
   LB move op cnt    : 0
   LB apply          : 3.32 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.07 us    (66.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.7710442487550716e-18,-7.736389653900666e-17,-2.2426396677210914e-17)
    sum a = (-1.6567021192404052e-16,-1.523903074042432e-17,8.892691270856457e-17)
    sum e = 2.592001604275049
    sum de = 3.1001405869507392e-19
Info: CFL hydro = 0.01122757583892644 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01122757583892644 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9412e+04 |  512 |      1 | 2.638e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1532.5860819196305 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.35926913005564, dt = 0.01122757583892644 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.22 us    (1.4%)
   patch tree reduce : 1206.00 ns (0.4%)
   gen split merge   : 691.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 916.00 ns  (0.3%)
   LB compute        : 279.54 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 3.11 us    (1.1%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1918.00 ns (63.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (-4.303198422594967e-19,-7.735072348261096e-17,-2.1094454308312473e-17)
    sum a = (1.0061873209621375e-16,-5.191647892838214e-18,7.879829601320498e-17)
    sum e = 2.59200160413172
    sum de = -1.0308390968084835e-18
Info: CFL hydro = 0.011227326273390204 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011227326273390204 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9422e+04 |  512 |      1 | 2.636e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1533.2754843403623 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.370496705894567, dt = 0.011227326273390204 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.48 us    (1.4%)
   patch tree reduce : 1493.00 ns (0.5%)
   gen split merge   : 708.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 960.00 ns  (0.3%)
   LB compute        : 299.13 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (68.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.0696335270575793e-18,-7.739170632473091e-17,-2.0356763150153335e-17)
    sum a = (-5.5402947854443775e-17,-8.929868563350984e-17,2.9847218446787946e-17)
    sum e = 2.5920016036788187
    sum de = 2.879912020664621e-20
Info: CFL hydro = 0.011227728049977613 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011227728049977613 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9642e+04 |  512 |      1 | 2.607e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1550.543818308421 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 24.381724032167956, dt = 0.011227728049977613 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.25 us    (1.5%)
   patch tree reduce : 1284.00 ns (0.4%)
   gen split merge   : 771.00 ns  (0.3%)
   split / merge op  : 0/0
   apply split merge : 990.00 ns  (0.3%)
   LB compute        : 275.10 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.84 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.13 us    (66.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.561957144850638e-19,-7.860655485900093e-17,-2.0186977089942105e-17)
    sum a = (1.2913986286583468e-16,-6.924709828985686e-17,2.820790476198987e-17)
    sum e = 2.5920016029516217
    sum de = 6.2680438096818225e-19
Info: CFL hydro = 0.011228775121412321 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011228775121412321 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9857e+04 |  512 |      1 | 2.578e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1567.634273877447 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 24.392951760217933, dt = 0.011228775121412321 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.09 us    (1.3%)
   patch tree reduce : 1743.00 ns (0.6%)
   gen split merge   : 718.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 892.00 ns  (0.3%)
   LB compute        : 297.61 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 3.25 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.01 us    (67.5%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.482421875
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (2.8951450611880424e-18,-7.927545338931585e-17,-1.9993772262805187e-17)
    sum a = (8.177247941276721e-17,-8.091513299234715e-17,-8.752764138475478e-18)
    sum e = 2.5920016020071412
    sum de = -3.006966962752766e-19
Info: CFL hydro = 0.011228641302206537 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011228641302206537 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9460e+04 |  512 |      1 | 2.631e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1536.4393575823028 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.404180535339346, dt = 0.011228641302206537 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.13 us    (1.4%)
   patch tree reduce : 1258.00 ns (0.4%)
   gen split merge   : 595.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1722.00 ns (0.6%)
   LB compute        : 275.96 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 2.80 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1999.00 ns (65.7%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (3.6094174524214925e-18,-8.063227819807284e-17,-2.02396693155249e-17)
    sum a = (-8.05839769912886e-17,-6.026032944124113e-17,4.786795959610402e-17)
    sum e = 2.5920016009104665
    sum de = -1.2781727174067392e-18
Info: CFL hydro = 0.011224707896792651 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011224707896792651 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9225e+04 |  512 |      1 | 2.663e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1517.851850125254 (tsim/hr)                             [sph::Model][rank=0]
---------------- t = 24.415409176641553, dt = 0.011224707896792651 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.05 us    (1.4%)
   patch tree reduce : 1528.00 ns (0.5%)
   gen split merge   : 638.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1673.00 ns (0.6%)
   LB compute        : 275.10 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.99 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (67.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (1.8149544367407343e-18,-8.103186090874236e-17,-1.9437576548320124e-17)
    sum a = (1.0763265279045697e-16,2.4840405001501885e-17,9.524997977850002e-17)
    sum e = 2.5920015997364825
    sum de = 1.1191422815597443e-19
Info: CFL hydro = 0.011221475593409986 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011221475593409986 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9704e+04 |  512 |      1 | 2.598e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1555.1364452594098 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.426633884538347, dt = 0.011221475593409986 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.74 us    (1.2%)
   patch tree reduce : 1205.00 ns (0.4%)
   gen split merge   : 678.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 906.00 ns  (0.3%)
   LB compute        : 288.59 us  (94.9%)
   LB move op cnt    : 0
   LB apply          : 2.73 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (68.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.1158482871894715e-18,-8.039223583708454e-17,-1.807050602903315e-17)
    sum a = (3.4829561110227834e-17,-2.6701419395848412e-17,4.55729204373867e-17)
    sum e = 2.592001598606616
    sum de = -1.0164395367051604e-19
Info: CFL hydro = 0.01121898302514556 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01121898302514556 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9688e+04 |  512 |      1 | 2.601e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1553.4131521505974 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.437855360131756, dt = 0.01121898302514556 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.69 us    (1.6%)
   patch tree reduce : 1389.00 ns (0.5%)
   gen split merge   : 646.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1182.00 ns (0.4%)
   LB compute        : 276.08 us  (94.3%)
   LB move op cnt    : 0
   LB apply          : 2.67 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 1882.00 ns (67.1%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (4.24465150528075e-18,-8.090159401771824e-17,-1.7856809780836257e-17)
    sum a = (1.2462662737737496e-16,5.23643628458359e-17,2.2792314910424772e-17)
    sum e = 2.592001597613216
    sum de = -2.329340604949326e-19
Info: CFL hydro = 0.011217258861928462 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011217258861928462 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9628e+04 |  512 |      1 | 2.609e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1548.3229022217454 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.4490743431569, dt = 0.011217258861928462 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.58 us    (1.4%)
   patch tree reduce : 1939.00 ns (0.6%)
   gen split merge   : 749.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 984.00 ns  (0.3%)
   LB compute        : 317.20 us  (94.8%)
   LB move op cnt    : 0
   LB apply          : 2.92 us    (0.9%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.27 us    (67.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.006913716438688e-18,-7.996630701362361e-17,-1.7678241683027895e-17)
    sum a = (-1.8192173841576757e-17,1.1354955062152504e-16,7.646227401236772e-17)
    sum e = 2.5920015968418144
    sum de = 1.1036839302723533e-18
Info: CFL hydro = 0.01121632106512804 sink sink = inf                                 [SPH][rank=0]
Info: cfl dt = 0.01121632106512804 cfl multiplier : 0.9999999999999997         [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9208e+04 |  512 |      1 | 2.666e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1514.9853100681614 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.46029160201883, dt = 0.01121632106512804 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.30 us    (1.5%)
   patch tree reduce : 1343.00 ns (0.5%)
   gen split merge   : 630.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 1087.00 ns (0.4%)
   LB compute        : 273.51 us  (94.4%)
   LB move op cnt    : 0
   LB apply          : 2.82 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.10 us    (64.8%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (5.1579834153825386e-18,-7.829040150550415e-17,-1.64399743818322e-17)
    sum a = (9.061672310954616e-17,7.342734818609198e-17,-6.468848894047862e-17)
    sum e = 2.592001596362872
    sum de = -7.589415207398531e-19
Info: CFL hydro = 0.011216177302888281 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011216177302888281 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9226e+04 |  512 |      1 | 2.663e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1516.2818629700446 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.47150792308396, dt = 0.011216177302888281 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 3.88 us    (1.4%)
   patch tree reduce : 1302.00 ns (0.5%)
   gen split merge   : 665.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 889.00 ns  (0.3%)
   LB compute        : 272.06 us  (94.6%)
   LB move op cnt    : 0
   LB apply          : 2.79 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.12 us    (65.2%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.683130611417898e-18,-7.777665230607189e-17,-1.8054405626771742e-17)
    sum a = (4.1048707401930564e-17,-1.4748114838744608e-16,4.588321909915205e-17)
    sum e = 2.5920015962262943
    sum de = -4.1758724299637007e-19
Info: CFL hydro = 0.011216824918057922 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011216824918057922 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9707e+04 |  512 |      1 | 2.598e-02 | 0.0% |   1.8% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1554.1318459510949 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.482724100386847, dt = 0.011216824918057922 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.69 us    (1.5%)
   patch tree reduce : 1176.00 ns (0.4%)
   gen split merge   : 628.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 958.00 ns  (0.3%)
   LB compute        : 288.34 us  (94.5%)
   LB move op cnt    : 0
   LB apply          : 3.08 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.04 us    (65.0%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.943664393466164e-18,-8.077718181842553e-17,-1.702690722790723e-17)
    sum a = (-3.8638038081517666e-17,1.8046209058347751e-16,-3.464221097482234e-17)
    sum e = 2.592001596457873
    sum de = -6.539094352803199e-19
Info: CFL hydro = 0.011218251178130495 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011218251178130495 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9835e+04 |  512 |      1 | 2.581e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 1564.3235178779748 (tsim/hr)                            [sph::Model][rank=0]
---------------- t = 24.493940925304905, dt = 0.006059074695095035 ----------------
Info: summary :                                                               [LoadBalance][rank=0]
Info:  - strategy "psweep" : max = 512 min = 512                              [LoadBalance][rank=0]
Info:  - strategy "round robin" : max = 512 min = 512                         [LoadBalance][rank=0]
Info: Loadbalance stats :                                                     [LoadBalance][rank=0]
    npatch = 1
    min = 512
    max = 512
    avg = 512
    efficiency = 100.00%
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 4.12 us    (1.4%)
   patch tree reduce : 1421.00 ns (0.5%)
   gen split merge   : 664.00 ns  (0.2%)
   split / merge op  : 0/0
   apply split merge : 802.00 ns  (0.3%)
   LB compute        : 277.19 us  (94.7%)
   LB move op cnt    : 0
   LB apply          : 2.85 us    (1.0%)
Info: Scheduler step timings :                                                  [Scheduler][rank=0]
   metadata sync     : 2.49 us    (67.4%)
Warning: High interface/patch volume ratio.                                  [InterfaceGen][rank=0]
    This can lead to high mpi overhead, try to increase the patch split crit
    patch 0 high interf/patch volume: 5.490234375
Warning: the unit system is not set                                           [sph::Config][rank=0]
Info: conservation infos :                                                     [sph::Model][rank=0]
    sum v = (6.173772430784208e-18,-7.777226128727332e-17,-1.771190616048357e-17)
    sum a = (-1.4805051715832685e-16,6.508294879588317e-17,-1.6961041945928733e-17)
    sum e = 2.592001577069342
    sum de = 4.895850435129856e-19
Info: CFL hydro = 0.011219599959794293 sink sink = inf                                [SPH][rank=0]
Info: cfl dt = 0.011219599959794293 cfl multiplier : 0.9999999999999997        [sph::Model][rank=0]
Info: Timestep perf report:                                                    [sph::Model][rank=0]
+======+============+======+========+===========+======+=============+=============+=============+
| rank | rate (N/s) | Nobj | Npatch |   tstep   | MPI  | alloc d% h% | mem (max) d | mem (max) h |
+======+============+======+========+===========+======+=============+=============+=============+
| 0    | 1.9531e+04 |  512 |      1 | 2.621e-02 | 0.0% |   1.7% 0.0% |     1.16 GB |     5.04 MB |
+------+------------+------+--------+-----------+------+-------------+-------------+-------------+
Info: estimated rate : 832.0907757693275 (tsim/hr)                             [sph::Model][rank=0]
Info: iteration since start : 2563                                                    [SPH][rank=0]
Info: time since start : 1833.1782021560002 (s)                                       [SPH][rank=0]
Info: collected : 1 patches                                                [PatchScheduler][rank=0]
adding ->  xyz
adding ->  vxyz
adding ->  axyz
adding ->  axyz_ext
adding ->  hpart
adding ->  uint
adding ->  duint
adding ->  alpha_AV
adding ->  divv
adding ->  dtdivv
adding ->  curlv
adding ->  soundspeed
hpart min=0.14992199043174534 max=0.1500735327270611 delta=0.0001515422953157486
Number of particle pairs: 130816
Distance min=0.120958 max=1.835447 mean=0.800721

Convert PNG sequence to Image sequence in mpl#

233 import matplotlib.animation as animation
234
235 render_gif = True
236
237
238 def show_image_sequence(glob_str):
239     if render_gif and shamrock.sys.world_rank() == 0:
240         import glob
241
242         files = sorted(glob.glob(glob_str))
243
244         from PIL import Image
245
246         image_array = []
247         for my_file in files:
248             image = Image.open(my_file)
249             image_array.append(image)
250
251         if not image_array:
252             raise RuntimeError(f"Warning: No images found for glob pattern: {glob_str}")
253
254         pixel_x, pixel_y = image_array[0].size
255
256         # Create the figure and axes objects
257         # Remove axes, ticks, and frame & set aspect ratio
258         dpi = 200
259         fig = plt.figure(dpi=dpi)
260         plt.gca().set_position((0, 0, 1, 1))
261         plt.gcf().set_size_inches(pixel_x / dpi, pixel_y / dpi)
262         plt.axis("off")
263
264         # Set the initial image with correct aspect ratio
265         im = plt.imshow(image_array[0], animated=True, aspect="auto")
266
267         def update(i):
268             im.set_array(image_array[i])
269             return (im,)
270
271         # Create the animation object
272         ani = animation.FuncAnimation(
273             fig,
274             update,
275             frames=len(image_array),
276             interval=50,
277             blit=True,
278             repeat_delay=10,
279         )
280
281         return ani
282
283
284 # If the animation is not returned only a static image will be shown in the doc
285 glob_str = os.path.join(dump_folder, f"{sim_name}_*.png")
286 ani = show_image_sequence(glob_str)
287
288 if render_gif and shamrock.sys.world_rank() == 0:
289     # To save the animation using Pillow as a gif
290     # writer = animation.PillowWriter(fps=15, metadata=dict(artist="Me"), bitrate=1800)
291     # ani.save("scatter.gif", writer=writer)
292
293     # Show the animation
294     plt.show()

Total running time of the script: (1 minutes 55.478 seconds)

Estimated memory usage: 119 MB

Gallery generated by Sphinx-Gallery